Source of the materials: Biopython cookbook (adapted) Status: Draft

Accessing NCBI’s Entrez databases

Entrez Guidelines

EInfo: Obtaining information about the Entrez databases

ESearch: Searching the Entrez databases

EPost: Uploading a list of identifiers

EFetch: Downloading full records from Entrez

History and WebEnv

Specialized parsers

Examples

Entrez (http://www.ncbi.nlm.nih.gov/Entrez) is a data retrieval system that provides users access to NCBI’s databases such as PubMed, GenBank, GEO, and many others. You can access Entrez from a web browser to manually enter queries, or you can use Biopython’s Bio.Entrez module for programmatic access to Entrez. The latter allows you for example to search PubMed or download GenBank records from within a Python script.

The Bio.Entrez module makes use of the Entrez Programming Utilities (also known as EUtils), consisting of eight tools that are described in detail on NCBI’s page at http://www.ncbi.nlm.nih.gov/entrez/utils/. Each of these tools corresponds to one Python function in the Bio.Entrez module, as described in the sections below. This module makes sure that the correct URL is used for the queries, and that not more than one request is made every three seconds, as required by NCBI.

The output returned by the Entrez Programming Utilities is typically in XML format. To parse such output, you have several options:

  1. Use Bio.Entrez’s parser to parse the XML output into a Python object;
  2. Use the DOM (Document Object Model) parser in Python’s standard library;
  3. Use the SAX (Simple API for XML) parser in Python’s standard library;
  4. Read the XML output as raw text, and parse it by string searching and manipulation.

For the DOM and SAX parsers, see the Python documentation. The parser in Bio.Entrez is discussed below.

NCBI uses DTD (Document Type Definition) files to describe the structure of the information contained in XML files. Most of the DTD files used by NCBI are included in the Biopython distribution. The Bio.Entrez parser makes use of the DTD files when parsing an XML file returned by NCBI Entrez.

Occasionally, you may find that the DTD file associated with a specific XML file is missing in the Biopython distribution. In particular, this may happen when NCBI updates its DTD files. If this happens, Entrez.read will show a warning message with the name and URL of the missing DTD file. The parser will proceed to access the missing DTD file through the internet, allowing the parsing of the XML file to continue. However, the parser is much faster if the DTD file is available locally. For this purpose, please download the DTD file from the URL in the warning message and place it in the directory ...site-packages/Bio/Entrez/DTDs, containing the other DTD files. If you don’t have write access to this directory, you can also place the DTD file in ~/.biopython/Bio/Entrez/DTDs, where ~ represents your home directory. Since this directory is read before the directory ...site-packages/Bio/Entrez/DTDs, you can also put newer versions of DTD files there if the ones in ...site-packages/Bio/Entrez/DTDs become outdated. Alternatively, if you installed Biopython from source, you can add the DTD file to the source code’s Bio/Entrez/DTDs directory, and reinstall Biopython. This will install the new DTD file in the correct location together with the other DTD files.

The Entrez Programming Utilities can also generate output in other formats, such as the Fasta or GenBank file formats for sequence databases, or the MedLine format for the literature database, discussed in Section Specialized parsers.

Entrez Guidelines

Before using Biopython to access the NCBI’s online resources (via Bio.Entrez or some of the other modules), please read the NCBI’s Entrez User Requirements. If the NCBI finds you are abusing their systems, they can and will ban your access!

To paraphrase:

  • For any series of more than 100 requests, do this at weekends or outside USA peak times. This is up to you to obey.
  • Use the http://eutils.ncbi.nlm.nih.gov address, not the standard NCBI Web address. Biopython uses this web address.
  • Make no more than three requests every seconds (relaxed from at most one request every three seconds in early 2009). This is automatically enforced by Biopython.
  • Use the optional email parameter so the NCBI can contact you if there is a problem. You can either explicitly set this as a parameter with each call to Entrez (e.g. include email=“A.N.Other@example.com” in the argument list), or you can set a global email address:
In [1]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"

Bio.Entrez will then use this email address with each call to Entrez. The example.com address is a reserved domain name specifically for documentation (RFC 2606). Please DO NOT use a random email – it’s better not to give an email at all. The email parameter will be mandatory from June 1, 2010. In case of excessive usage, NCBI will attempt to contact a user at the e-mail address provided prior to blocking access to the E-utilities.

If you are using Biopython within some larger software suite, use the tool parameter to specify this. You can either explicitly set the tool name as a parameter with each call to Entrez (e.g. include tool=“MyLocalScript” in the argument list), or you can set a global tool name:

In [2]:
from Bio import Entrez
Entrez.tool = "MyLocalScript"
The tool parameter will default to Biopython.
  • For large queries, the NCBI also recommend using their session history feature (the WebEnv session cookie string, see Section History and WebEnv). This is only slightly more complicated.

In conclusion, be sensible with your usage levels. If you plan to download lots of data, consider other options. For example, if you want easy access to all the human genes, consider fetching each chromosome by FTP as a GenBank file, and importing these into your own BioSQL database (see Section [sec:BioSQL]).

EInfo: Obtaining information about the Entrez databases

EInfo provides field index term counts, last update, and available links for each of NCBI’s databases. In addition, you can use EInfo to obtain a list of all database names accessible through the Entrez utilities. The variable result now contains a list of databases in XML format:

In [3]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.einfo()
result = handle.read()
print(result)

<?xml version="1.0" encoding="UTF-8"?>
<!DOCTYPE eInfoResult PUBLIC "-//NLM//DTD einfo 20130322//EN" "http://eutils.ncbi.nlm.nih.gov/eutils/dtd/20130322/einfo.dtd">
<eInfoResult>
<DbList>

        <DbName>pubmed</DbName>
        <DbName>protein</DbName>
        <DbName>nuccore</DbName>
        <DbName>nucleotide</DbName>
        <DbName>nucgss</DbName>
        <DbName>nucest</DbName>
        <DbName>structure</DbName>
        <DbName>genome</DbName>
        <DbName>annotinfo</DbName>
        <DbName>assembly</DbName>
        <DbName>bioproject</DbName>
        <DbName>biosample</DbName>
        <DbName>blastdbinfo</DbName>
        <DbName>books</DbName>
        <DbName>cdd</DbName>
        <DbName>clinvar</DbName>
        <DbName>clone</DbName>
        <DbName>gap</DbName>
        <DbName>gapplus</DbName>
        <DbName>grasp</DbName>
        <DbName>dbvar</DbName>
        <DbName>epigenomics</DbName>
        <DbName>gene</DbName>
        <DbName>gds</DbName>
        <DbName>geoprofiles</DbName>
        <DbName>homologene</DbName>
        <DbName>medgen</DbName>
        <DbName>mesh</DbName>
        <DbName>ncbisearch</DbName>
        <DbName>nlmcatalog</DbName>
        <DbName>omim</DbName>
        <DbName>orgtrack</DbName>
        <DbName>pmc</DbName>
        <DbName>popset</DbName>
        <DbName>probe</DbName>
        <DbName>proteinclusters</DbName>
        <DbName>pcassay</DbName>
        <DbName>biosystems</DbName>
        <DbName>pccompound</DbName>
        <DbName>pcsubstance</DbName>
        <DbName>pubmedhealth</DbName>
        <DbName>seqannot</DbName>
        <DbName>snp</DbName>
        <DbName>sra</DbName>
        <DbName>taxonomy</DbName>
        <DbName>unigene</DbName>
        <DbName>gencoll</DbName>
        <DbName>gtr</DbName>
</DbList>

</eInfoResult>

Since this is a fairly simple XML file, we could extract the information it contains simply by string searching. Using Bio.Entrez’s parser instead, we can directly parse this XML file into a Python object:

In [4]:
from Bio import Entrez
handle = Entrez.einfo()
record = Entrez.read(handle)

Now record is a dictionary with exactly one key:

In [5]:
record.keys()
Out[5]:
dict_keys(['DbList'])

The values stored in this key is the list of database names shown in the XML above:

In [6]:
record["DbList"]
Out[6]:
['pubmed', 'protein', 'nuccore', 'nucleotide', 'nucgss', 'nucest', 'structure', 'genome', 'annotinfo', 'assembly', 'bioproject', 'biosample', 'blastdbinfo', 'books', 'cdd', 'clinvar', 'clone', 'gap', 'gapplus', 'grasp', 'dbvar', 'epigenomics', 'gene', 'gds', 'geoprofiles', 'homologene', 'medgen', 'mesh', 'ncbisearch', 'nlmcatalog', 'omim', 'orgtrack', 'pmc', 'popset', 'probe', 'proteinclusters', 'pcassay', 'biosystems', 'pccompound', 'pcsubstance', 'pubmedhealth', 'seqannot', 'snp', 'sra', 'taxonomy', 'unigene', 'gencoll', 'gtr']

For each of these databases, we can use EInfo again to obtain more information:

In [7]:
from Bio import Entrez
handle = Entrez.einfo(db="pubmed")
record = Entrez.read(handle)
record["DbInfo"]["Description"]
Out[7]:
'PubMed bibliographic record'
In [8]:
record['DbInfo'].keys()
Out[8]:
dict_keys(['LastUpdate', 'Count', 'DbName', 'Description', 'MenuName', 'FieldList', 'DbBuild', 'LinkList'])
In [9]:
handle = Entrez.einfo(db="pubmed")
record = Entrez.read(handle)
record["DbInfo"]["Description"]
Out[9]:
'PubMed bibliographic record'
In [10]:
record["DbInfo"]["Count"]
Out[10]:
'25641704'
In [11]:
record["DbInfo"]["LastUpdate"]
Out[11]:
'2016/01/12 18:56'

Try record["DbInfo"].keys() for other information stored in this record. One of the most useful is a list of possible search fields for use with ESearch:

In [12]:
for field in record["DbInfo"]["FieldList"]:
    print("%(Name)s, %(FullName)s, %(Description)s" % field)
ALL, All Fields, All terms from all searchable fields
UID, UID, Unique number assigned to publication
FILT, Filter, Limits the records
TITL, Title, Words in title of publication
WORD, Text Word, Free text associated with publication
MESH, MeSH Terms, Medical Subject Headings assigned to publication
MAJR, MeSH Major Topic, MeSH terms of major importance to publication
AUTH, Author, Author(s) of publication
JOUR, Journal, Journal abbreviation of publication
AFFL, Affiliation, Author's institutional affiliation and address
ECNO, EC/RN Number, EC number for enzyme or CAS registry number
SUBS, Supplementary Concept, CAS chemical name or MEDLINE Substance Name
PDAT, Date - Publication, Date of publication
EDAT, Date - Entrez, Date publication first accessible through Entrez
VOL, Volume, Volume number of publication
PAGE, Pagination, Page number(s) of publication
PTYP, Publication Type, Type of publication (e.g., review)
LANG, Language, Language of publication
ISS, Issue, Issue number of publication
SUBH, MeSH Subheading, Additional specificity for MeSH term
SI, Secondary Source ID, Cross-reference from publication to other databases
MHDA, Date - MeSH, Date publication was indexed with MeSH terms
TIAB, Title/Abstract, Free text associated with Abstract/Title
OTRM, Other Term, Other terms associated with publication
INVR, Investigator, Investigator
COLN, Author - Corporate, Corporate Author of publication
CNTY, Place of Publication, Country of publication
PAPX, Pharmacological Action, MeSH pharmacological action pre-explosions
GRNT, Grant Number, NIH Grant Numbers
MDAT, Date - Modification, Date of last modification
CDAT, Date - Completion, Date of completion
PID, Publisher ID, Publisher ID
FAUT, Author - First, First Author of publication
FULL, Author - Full, Full Author Name(s) of publication
FINV, Investigator - Full, Full name of investigator
TT, Transliterated Title, Words in transliterated title of publication
LAUT, Author - Last, Last Author of publication
PPDT, Print Publication Date, Date of print publication
EPDT, Electronic Publication Date, Date of Electronic publication
LID, Location ID, ELocation ID
CRDT, Date - Create, Date publication first accessible through Entrez
BOOK, Book, ID of the book that contains the document
ED, Editor, Section's Editor
ISBN, ISBN, ISBN
PUBN, Publisher, Publisher's name
AUCL, Author Cluster ID, Author Cluster ID
EID, Extended PMID, Extended PMID
DSO, DSO, Additional text from the summary
AUID, Author - Identifier, Author Identifier
PS, Subject - Personal Name, Personal Name as Subject

That’s a long list, but indirectly this tells you that for the PubMed database, you can do things like Jones[AUTH] to search the author field, or Sanger[AFFL] to restrict to authors at the Sanger Centre. This can be very handy - especially if you are not so familiar with a particular database.

ESearch: Searching the Entrez databases

To search any of these databases, we use Bio.Entrez.esearch(). For example, let’s search in PubMed for publications related to Biopython:

In [13]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.esearch(db="pubmed", term="biopython")
record = Entrez.read(handle)
record["IdList"]
Out[13]:
['24929426', '24497503', '24267035', '24194598', '23842806', '23157543', '22909249', '22399473', '21666252', '21210977', '20015970', '19811691', '19773334', '19304878', '18606172', '21585724', '16403221', '16377612', '14871861', '14630660']
In [14]:
record
Out[14]:
{'TranslationStack': [{'Explode': 'N', 'Term': 'biopython[All Fields]', 'Field': 'All Fields', 'Count': '21'}, 'GROUP'], 'IdList': ['24929426', '24497503', '24267035', '24194598', '23842806', '23157543', '22909249', '22399473', '21666252', '21210977', '20015970', '19811691', '19773334', '19304878', '18606172', '21585724', '16403221', '16377612', '14871861', '14630660'], 'TranslationSet': [], 'QueryTranslation': 'biopython[All Fields]', 'Count': '21', 'RetStart': '0', 'RetMax': '20'}

In this output, you see seven PubMed IDs (including 19304878 which is the PMID for the Biopython application), which can be retrieved by EFetch (see section EFetch: Downloading full records from Entrez).

You can also use ESearch to search GenBank. Here we’ll do a quick search for the matK gene in Cypripedioideae orchids (see Section [sec:entrez-einfo] about EInfo for one way to find out which fields you can search in each Entrez database):

In [15]:
handle = Entrez.esearch(db="nucleotide", term="Cypripedioideae[Orgn] AND matK[Gene]")
record = Entrez.read(handle)
record["Count"]
Out[15]:
'334'
In [16]:
record["IdList"]
Out[16]:
['844174433', '937957673', '694174838', '944541375', '575524123', '575524121', '575524119', '575524117', '575524115', '575524113', '575524111', '575524109', '575524107', '575524105', '575524103', '575524101', '575524099', '575524097', '575524095', '575524093']

Each of the IDs (126789333, 37222967, 37222966, …) is a GenBank identifier. See section EFetch: Downloading full records from Entrez for information on how to actually download these GenBank records.

Note that instead of a species name like Cypripedioideae[Orgn], you can restrict the search using an NCBI taxon identifier, here this would be txid158330[Orgn]. This isn’t currently documented on the ESearch help page - the NCBI explained this in reply to an email query. You can often deduce the search term formatting by playing with the Entrez web interface. For example, including complete[prop] in a genome search restricts to just completed genomes.

As a final example, let’s get a list of computational journal titles:

In [17]:
# nlmcatalog
# handle = Entrez.esearch(db="nlmcatalog", term="computational")
# record = Entrez.read(handle)
# record["Count"]
handle = Entrez.esearch(db="nlmcatalog", term="biopython[Journal]", RetMax='20')
record = Entrez.read(handle)
print("{} computational Journals found".format(record["Count"]))
print("The first 20 are\n{}".format(record['IdList']))
0 computational Journals found
The first 20 are
[]

Again, we could use EFetch to obtain more information for each of these journal IDs.

ESearch has many useful options — see the ESearch help page for more information.

EPost: Uploading a list of identifiers

EPost uploads a list of UIs for use in subsequent search strategies; see the EPost help page for more information. It is available from Biopython through the Bio.Entrez.epost() function.

To give an example of when this is useful, suppose you have a long list of IDs you want to download using EFetch (maybe sequences, maybe citations – anything). When you make a request with EFetch your list of IDs, the database etc, are all turned into a long URL sent to the server. If your list of IDs is long, this URL gets long, and long URLs can break (e.g. some proxies don’t cope well).

Instead, you can break this up into two steps, first uploading the list of IDs using EPost (this uses an “HTML post” internally, rather than an “HTML get”, getting round the long URL problem). With the history support, you can then refer to this long list of IDs, and download the associated data with EFetch.

Let’s look at a simple example to see how EPost works – uploading some PubMed identifiers:

In [18]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
id_list = ["19304878", "18606172", "16403221", "16377612", "14871861", "14630660"]
print(Entrez.epost("pubmed", id=",".join(id_list)).read())
<?xml version="1.0"?>
<!DOCTYPE ePostResult PUBLIC "-//NLM//DTD ePostResult, 11 May 2002//EN" "http://www.ncbi.nlm.nih.gov/entrez/query/DTD/ePost_020511.dtd">
<ePostResult>
        <QueryKey>1</QueryKey>
        <WebEnv>NCID_1_242547791_130.14.22.215_9001_1452651583_567658845_0MetA0_S_MegaStore_F_1</WebEnv>
</ePostResult>

The returned XML includes two important strings, QueryKey and WebEnv which together define your history session. You would extract these values for use with another Entrez call such as EFetch:

In [19]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
id_list = ["19304878", "18606172", "16403221", "16377612", "14871861", "14630660"]
search_results = Entrez.read(Entrez.epost("pubmed", id=",".join(id_list)))
webenv = search_results["WebEnv"]
query_key = search_results["QueryKey"]

Section History and WebEnv shows how to use the history feature.

ESummary: Retrieving summaries from primary IDs

ESummary retrieves document summaries from a list of primary IDs (see the ESummary help page for more information). In Biopython, ESummary is available as Bio.Entrez.esummary(). Using the search result above, we can for example find out more about the journal with ID 30367:

In [20]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.esummary(db="nlmcatalog", term="[journal]", id="101660833")
record = Entrez.read(handle)
info = record[0]['TitleMainList'][0]
print("Journal info\nid: {}\nTitle: {}".format(record[0]["Id"], info["Title"]))
Journal info
id: 101660833
Title: IEEE transactions on computational imaging.

EFetch: Downloading full records from Entrez

EFetch is what you use when you want to retrieve a full record from Entrez. This covers several possible databases, as described on the main EFetch Help page.

For most of their databases, the NCBI support several different file formats. Requesting a specific file format from Entrez using Bio.Entrez.efetch() requires specifying the rettype and/or retmode optional arguments. The different combinations are described for each database type on the pages linked to on NCBI efetch webpage (e.g. literature, sequences and taxonomy).

One common usage is downloading sequences in the FASTA or GenBank/GenPept plain text formats (which can then be parsed with Bio.SeqIO, see Sections [sec:SeqIO_GenBank_Online] and EFetch: Downloading full records from Entrez). From the Cypripedioideae example above, we can download GenBank record 186972394 using Bio.Entrez.efetch:

In [21]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.efetch(db="nucleotide", id="186972394", rettype="gb", retmode="text")
print(handle.read())
LOCUS       EU490707                1302 bp    DNA     linear   PLN 15-JAN-2009
DEFINITION  Selenipedium aequinoctiale maturase K (matK) gene, partial cds;
            chloroplast.
ACCESSION   EU490707
VERSION     EU490707.1  GI:186972394
KEYWORDS    .
SOURCE      chloroplast Selenipedium aequinoctiale
  ORGANISM  Selenipedium aequinoctiale
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; Liliopsida; Asparagales; Orchidaceae;
            Cypripedioideae; Selenipedium.
REFERENCE   1  (bases 1 to 1302)
  AUTHORS   Neubig,K.M., Whitten,W.M., Carlsward,B.S., Blanco,M.A., Endara,L.,
            Williams,N.H. and Moore,M.
  TITLE     Phylogenetic utility of ycf1 in orchids: a plastid gene more
            variable than matK
  JOURNAL   Plant Syst. Evol. 277 (1-2), 75-84 (2009)
REFERENCE   2  (bases 1 to 1302)
  AUTHORS   Neubig,K.M., Whitten,W.M., Carlsward,B.S., Blanco,M.A.,
            Endara,C.L., Williams,N.H. and Moore,M.J.
  TITLE     Direct Submission
  JOURNAL   Submitted (14-FEB-2008) Department of Botany, University of
            Florida, 220 Bartram Hall, Gainesville, FL 32611-8526, USA
FEATURES             Location/Qualifiers
     source          1..1302
                     /organism="Selenipedium aequinoctiale"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /specimen_voucher="FLAS:Blanco 2475"
                     /db_xref="taxon:256374"
     gene            <1..>1302
                     /gene="matK"
     CDS             <1..>1302
                     /gene="matK"
                     /codon_start=1
                     /transl_table=11
                     /product="maturase K"
                     /protein_id="ACC99456.1"
                     /db_xref="GI:186972395"
                     /translation="IFYEPVEIFGYDNKSSLVLVKRLITRMYQQNFLISSVNDSNQKG
                     FWGHKHFFSSHFSSQMVSEGFGVILEIPFSSQLVSSLEEKKIPKYQNLRSIHSIFPFL
                     EDKFLHLNYVSDLLIPHPIHLEILVQILQCRIKDVPSLHLLRLLFHEYHNLNSLITSK
                     KFIYAFSKRKKRFLWLLYNSYVYECEYLFQFLRKQSSYLRSTSSGVFLERTHLYVKIE
                     HLLVVCCNSFQRILCFLKDPFMHYVRYQGKAILASKGTLILMKKWKFHLVNFWQSYFH
                     FWSQPYRIHIKQLSNYSFSFLGYFSSVLENHLVVRNQMLENSFIINLLTKKFDTIAPV
                     ISLIGSLSKAQFCTVLGHPISKPIWTDFSDSDILDRFCRICRNLCRYHSGSSKKQVLY
                     RIKYILRLSCARTLARKHKSTVRTFMRRLGSGLLEEFFMEEE"
ORIGIN
        1 attttttacg aacctgtgga aatttttggt tatgacaata aatctagttt agtacttgtg
       61 aaacgtttaa ttactcgaat gtatcaacag aattttttga tttcttcggt taatgattct
      121 aaccaaaaag gattttgggg gcacaagcat tttttttctt ctcatttttc ttctcaaatg
      181 gtatcagaag gttttggagt cattctggaa attccattct cgtcgcaatt agtatcttct
      241 cttgaagaaa aaaaaatacc aaaatatcag aatttacgat ctattcattc aatatttccc
      301 tttttagaag acaaattttt acatttgaat tatgtgtcag atctactaat accccatccc
      361 atccatctgg aaatcttggt tcaaatcctt caatgccgga tcaaggatgt tccttctttg
      421 catttattgc gattgctttt ccacgaatat cataatttga atagtctcat tacttcaaag
      481 aaattcattt acgccttttc aaaaagaaag aaaagattcc tttggttact atataattct
      541 tatgtatatg aatgcgaata tctattccag tttcttcgta aacagtcttc ttatttacga
      601 tcaacatctt ctggagtctt tcttgagcga acacatttat atgtaaaaat agaacatctt
      661 ctagtagtgt gttgtaattc ttttcagagg atcctatgct ttctcaagga tcctttcatg
      721 cattatgttc gatatcaagg aaaagcaatt ctggcttcaa agggaactct tattctgatg
      781 aagaaatgga aatttcatct tgtgaatttt tggcaatctt attttcactt ttggtctcaa
      841 ccgtatagga ttcatataaa gcaattatcc aactattcct tctcttttct ggggtatttt
      901 tcaagtgtac tagaaaatca tttggtagta agaaatcaaa tgctagagaa ttcatttata
      961 ataaatcttc tgactaagaa attcgatacc atagccccag ttatttctct tattggatca
     1021 ttgtcgaaag ctcaattttg tactgtattg ggtcatccta ttagtaaacc gatctggacc
     1081 gatttctcgg attctgatat tcttgatcga ttttgccgga tatgtagaaa tctttgtcgt
     1141 tatcacagcg gatcctcaaa aaaacaggtt ttgtatcgta taaaatatat acttcgactt
     1201 tcgtgtgcta gaactttggc acggaaacat aaaagtacag tacgcacttt tatgcgaaga
     1261 ttaggttcgg gattattaga agaattcttt atggaagaag aa
//


The arguments rettype="gb" and retmode="text" let us download this record in the GenBank format.

Note that until Easter 2009, the Entrez EFetch API let you use “genbank” as the return type, however the NCBI now insist on using the official return types of “gb” or “gbwithparts” (or “gp” for proteins) as described on online. Also not that until Feb 2012, the Entrez EFetch API would default to returning plain text files, but now defaults to XML.

Alternatively, you could for example use rettype="fasta" to get the Fasta-format; see the EFetch Sequences Help page for other options. Remember – the available formats depend on which database you are downloading from - see the main EFetch Help page.

If you fetch the record in one of the formats accepted by Bio.SeqIO (see Chapter [chapter:Bio.SeqIO]), you could directly parse it into a SeqRecord:

In [22]:
from Bio import Entrez, SeqIO
handle = Entrez.efetch(db="nucleotide", id="186972394", rettype="gb", retmode="text")
record = SeqIO.read(handle, "genbank")
handle.close()
print(record)
ID: EU490707.1
Name: EU490707
Description: Selenipedium aequinoctiale maturase K (matK) gene, partial cds; chloroplast.
Number of features: 3
/gi=186972394
/taxonomy=['Eukaryota', 'Viridiplantae', 'Streptophyta', 'Embryophyta', 'Tracheophyta', 'Spermatophyta', 'Magnoliophyta', 'Liliopsida', 'Asparagales', 'Orchidaceae', 'Cypripedioideae', 'Selenipedium']
/date=15-JAN-2009
/references=[Reference(title='Phylogenetic utility of ycf1 in orchids: a plastid gene more variable than matK', ...), Reference(title='Direct Submission', ...)]
/organism=Selenipedium aequinoctiale
/sequence_version=1
/accessions=['EU490707']
/data_file_division=PLN
/source=chloroplast Selenipedium aequinoctiale
/keywords=['']
Seq('ATTTTTTACGAACCTGTGGAAATTTTTGGTTATGACAATAAATCTAGTTTAGTA...GAA', IUPACAmbiguousDNA())

Note that a more typical use would be to save the sequence data to a local file, and then parse it with Bio.SeqIO. This can save you having to re-download the same file repeatedly while working on your script, and places less load on the NCBI’s servers. For example:

In [23]:
import os
from Bio import SeqIO
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
filename = "gi_186972394.gbk"
if not os.path.isfile(filename):
    # Downloading...
    with Entrez.efetch(db="nucleotide",id="186972394",rettype="gb", retmode="text") as net_handle:
        with open(filename, "w") as out_handle:
            out_handle.write(net_handle.read())
        print("Saved")

print("Parsing...")
record = SeqIO.read(filename, "genbank")
print(record)
---------------------------------------------------------------------------
AttributeError                            Traceback (most recent call last)
<ipython-input-23-d6d046a39755> in <module>()
      6 if not os.path.isfile(filename):
      7     # Downloading...
----> 8     with Entrez.efetch(db="nucleotide",id="186972394",rettype="gb", retmode="text") as net_handle:
      9         with open(filename, "w") as out_handle:
     10             out_handle.write(net_handle.read())

AttributeError: __exit__

To get the output in XML format, which you can parse using the Bio.Entrez.read() function, use retmode="xml":

In [24]:
from Bio import Entrez
handle = Entrez.efetch(db="nucleotide", id="186972394", retmode="xml")
record = Entrez.read(handle)
handle.close()
record[0]["GBSeq_definition"]
Out[24]:
'Selenipedium aequinoctiale maturase K (matK) gene, partial cds; chloroplast'
In [25]:
record[0]["GBSeq_source"]
Out[25]:
'chloroplast Selenipedium aequinoctiale'

So, that dealt with sequences. For examples of parsing file formats specific to the other databases (e.g. the MEDLINE format used in PubMed), see Section Specialized parsers.

If you want to perform a search with Bio.Entrez.esearch(), and then download the records with Bio.Entrez.efetch(), you should use the WebEnv history feature – see Section History and WebEnv.

EGQuery: Global Query - counts for search terms

EGQuery provides counts for a search term in each of the Entrez databases (i.e. a global query). This is particularly useful to find out how many items your search terms would find in each database without actually performing lots of separate searches with ESearch (see the example in [subsec:entrez_example_genbank] below).

In this example, we use Bio.Entrez.egquery() to obtain the counts for “Biopython”:

In [31]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.egquery(term="biopython")
record = Entrez.read(handle)
for row in record["eGQueryResult"]:
    print(row["DbName"], row["Count"])
pubmed 21
pmc 560
mesh 0
books 2
pubmedhealth 2
omim 0
ncbisearch 0
nuccore 0
nucgss 0
nucest 0
protein 0
genome 0
structure 0
taxonomy 0
snp 0
dbvar 0
epigenomics 0
gene 0
sra 0
biosystems 0
unigene 0
cdd 0
clone 0
popset 0
geoprofiles 0
gds 16
homologene 0
pccompound 0
pcsubstance 0
pcassay 0
nlmcatalog 0
probe 0
gap 0
proteinclusters 0
bioproject 0
biosample 0

See the EGQuery help page for more information.

ESpell: Obtaining spelling suggestions

ESpell retrieves spelling suggestions. In this example, we use Bio.Entrez.espell() to obtain the correct spelling of Biopython:

In [32]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.espell(term="biopythooon")
record = Entrez.read(handle)
record["Query"]
Out[32]:
'biopythooon'
In [33]:
record["CorrectedQuery"]
Out[33]:
'biopython'

See the ESpell help page for more information. The main use of this is for GUI tools to provide automatic suggestions for search terms.

Parsing huge Entrez XML files

The Entrez.read function reads the entire XML file returned by Entrez into a single Python object, which is kept in memory. To parse Entrez XML files too large to fit in memory, you can use the function Entrez.parse. This is a generator function that reads records in the XML file one by one. This function is only useful if the XML file reflects a Python list object (in other words, if Entrez.read on a computer with infinite memory resources would return a Python list).

For example, you can download the entire Entrez Gene database for a given organism as a file from NCBI’s ftp site. These files can be very large. As an example, on September 4, 2009, the file Homo_sapiens.ags.gz, containing the Entrez Gene database for human, had a size of 116576 kB. This file, which is in the ASN format, can be converted into an XML file using NCBI’s gene2xml program (see NCBI’s ftp site for more information):

gene2xml -b T -i Homo_sapiens.ags -o Homo_sapiens.xml

The resulting XML file has a size of 6.1 GB. Attempting Entrez.read on this file will result in a MemoryError on many computers.

The XML file Homo_sapiens.xml consists of a list of Entrez gene records, each corresponding to one Entrez gene in human. Entrez.parse retrieves these gene records one by one. You can then print out or store the relevant information in each record by iterating over the records. For example, this script iterates over the Entrez gene records and prints out the gene numbers and names for all current genes:

TODO: need alternate example, download option or ...

from Bio import Entrez
handle = open("Homo_sapiens.xml")
records = Entrez.parse(handle)
for record in records:
    status = record['Entrezgene_track-info']['Gene-track']['Gene-track_status']
    if status.attributes['value']=='discontinued':
        continue
    geneid = record['Entrezgene_track-info']['Gene-track']['Gene-track_geneid']
    genename = record['Entrezgene_gene']['Gene-ref']['Gene-ref_locus']
    print(geneid, genename)

This will print:

1 A1BG
2 A2M
3 A2MP
8 AA
9 NAT1
10 NAT2
11 AACP
12 SERPINA3
13 AADAC
14 AAMP
15 AANAT
16 AARS
17 AAVS1
...

Handling errors

Three things can go wrong when parsing an XML file:

  • The file may not be an XML file to begin with;
  • The file may end prematurely or otherwise be corrupted;
  • The file may be correct XML, but contain items that are not represented in the associated DTD.

The first case occurs if, for example, you try to parse a Fasta file as if it were an XML file:

In [34]:
from Bio import Entrez
from Bio.Entrez.Parser import NotXMLError
handle = open("data/NC_005816.fna", 'rb') # a Fasta file
try:
    record = Entrez.read(handle)
except NotXMLError as e:
    print('We are expecting to get NotXMLError')
    print(e)
We are expecting to get NotXMLError
Failed to parse the XML data (syntax error: line 1, column 0). Please make sure that the input data are in XML format.

Here, the parser didn’t find the <?xml ... tag with which an XML file is supposed to start, and therefore decides (correctly) that the file is not an XML file.

When your file is in the XML format but is corrupted (for example, by ending prematurely), the parser will raise a CorruptedXMLError. Here is an example of an XML file that ends prematurely:

<?xml version="1.0"?>
<!DOCTYPE eInfoResult PUBLIC "-//NLM//DTD eInfoResult, 11 May 2002//EN" "http://www.ncbi.nlm.nih.gov/entrez/query/DTD/eInfo_020511.dtd">
<eInfoResult>
<DbList>
        <DbName>pubmed</DbName>
        <DbName>protein</DbName>
        <DbName>nucleotide</DbName>
        <DbName>nuccore</DbName>
        <DbName>nucgss</DbName>
        <DbName>nucest</DbName>
        <DbName>structure</DbName>
        <DbName>genome</DbName>
        <DbName>books</DbName>
        <DbName>cancerchromosomes</DbName>
        <DbName>cdd</DbName>

which will generate the following traceback:

---------------------------------------------------------------------------
ExpatError                                Traceback (most recent call last)
/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/Parser.py in read(self, handle)
    214         try:
--> 215             self.parser.ParseFile(handle)
    216         except expat.ExpatError as e:

ExpatError: syntax error: line 1, column 0

During handling of the above exception, another exception occurred:

NotXMLError                               Traceback (most recent call last)
<ipython-input-63-ac0523d72453> in <module>()
----> 1 Entrez.read(handle)

/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/__init__.py in read(handle, validate)
    419     from .Parser import DataHandler
    420     handler = DataHandler(validate)
--> 421     record = handler.read(handle)
    422     return record
    423

/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/Parser.py in read(self, handle)
    223                 # We have not seen the initial <!xml declaration, so probably
    224                 # the input data is not in XML format.
--> 225                 raise NotXMLError(e)
    226         try:
    227             return self.object

NotXMLError: Failed to parse the XML data (syntax error: line 1, column 0). Please make sure that the input data are in XML format.

Note that the error message tells you at what point in the XML file the error was detected.

The third type of error occurs if the XML file contains tags that do not have a description in the corresponding DTD file. This is an example of such an XML file:

<?xml version="1.0"?>
<!DOCTYPE eInfoResult PUBLIC "-//NLM//DTD eInfoResult, 11 May 2002//EN" "http://www.ncbi.nlm.nih.gov/entrez/query/DTD/eInfo_020511.dtd">
<eInfoResult>
        <DbInfo>
        <DbName>pubmed</DbName>
        <MenuName>PubMed</MenuName>
        <Description>PubMed bibliographic record</Description>
        <Count>20161961</Count>
        <LastUpdate>2010/09/10 04:52</LastUpdate>
        <FieldList>
                <Field>
...
                </Field>
        </FieldList>
        <DocsumList>
                <Docsum>
                        <DsName>PubDate</DsName>
                        <DsType>4</DsType>
                        <DsTypeName>string</DsTypeName>
                </Docsum>
                <Docsum>
                        <DsName>EPubDate</DsName>
...
        </DbInfo>
</eInfoResult>

In this file, for some reason the tag <DocsumList> (and several others) are not listed in the DTD file eInfo_020511.dtd, which is specified on the second line as the DTD for this XML file. By default, the parser will stop and raise a ValidationError if it cannot find some tag in the DTD:

from Bio import Entrez
handle = open("data/einfo3.xml", 'rb')
record = Entrez.read(handle)
---------------------------------------------------------------------------
ValidationError                           Traceback (most recent call last)
<ipython-input-65-cfb96ec3d2ca> in <module>()
      1 from Bio import Entrez
      2 handle = open("data/einfo3.xml", 'rb')
----> 3 record = Entrez.read(handle)

/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/__init__.py in read(handle, validate)
    419     from .Parser import DataHandler
    420     handler = DataHandler(validate)
--> 421     record = handler.read(handle)
    422     return record
    423

/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/Parser.py in read(self, handle)
    213             raise IOError("Can't parse a closed handle")
    214         try:
--> 215             self.parser.ParseFile(handle)
    216         except expat.ExpatError as e:
    217             if self.parser.StartElementHandler:

-------src-dir--------/Python-3.5.1/Modules/pyexpat.c in StartElement()

/Users/vincentdavis/anaconda/envs/py35/lib/python3.5/site-packages/Bio/Entrez/Parser.py in startElementHandler(self, name, attrs)
    348             # Element not found in DTD
    349             if self.validating:
--> 350                 raise ValidationError(name)
    351             else:
    352                 # this will not be stored in the record

ValidationError: Failed to find tag 'DocsumList' in the DTD. To skip all tags that are not represented in the DTD, please call Bio.Entrez.read or Bio.Entrez.parse with validate=False.

Optionally, you can instruct the parser to skip such tags instead of raising a ValidationError. This is done by calling Entrez.read or Entrez.parse with the argument validate equal to False:

In [35]:
from Bio import Entrez
handle = open("data/einfo3.xml", 'rb')
record = Entrez.read(handle, validate=False)

Of course, the information contained in the XML tags that are not in the DTD are not present in the record returned by Entrez.read.

Specialized parsers

The Bio.Entrez.read() function can parse most (if not all) XML output returned by Entrez. Entrez typically allows you to retrieve records in other formats, which may have some advantages compared to the XML format in terms of readability (or download size).

To request a specific file format from Entrez using Bio.Entrez.efetch() requires specifying the rettype and/or retmode optional arguments. The different combinations are described for each database type on the NCBI efetch webpage.

One obvious case is you may prefer to download sequences in the FASTA or GenBank/GenPept plain text formats (which can then be parsed with Bio.SeqIO, see Sections [sec:SeqIO_GenBank_Online] and EFetch: Downloading full records from Entrez). For the literature databases, Biopython contains a parser for the MEDLINE format used in PubMed.

Parsing Medline records

You can find the Medline parser in Bio.Medline. Suppose we want to parse the file pubmed_result1.txt, containing one Medline record. You can find this file in Biopython’s Tests\Medline directory. The file looks like this:

PMID- 12230038
OWN - NLM
STAT- MEDLINE
DA  - 20020916
DCOM- 20030606
LR  - 20041117
PUBM- Print
IS  - 1467-5463 (Print)
VI  - 3
IP  - 3
DP  - 2002 Sep
TI  - The Bio* toolkits--a brief overview.
PG  - 296-302
AB  - Bioinformatics research is often difficult to do with commercial software. The
      Open Source BioPerl, BioPython and Biojava projects provide toolkits with
...

We first open the file and then parse it:

In [36]:
from Bio import Medline
with open("data/pubmed_result1.txt") as handle:
    record = Medline.read(handle)

The record now contains the Medline record as a Python dictionary:

In [37]:
record["PMID"]
Out[37]:
'12230038'
In [38]:
record["AB"]
Out[38]:
'Bioinformatics research is often difficult to do with commercial software. The Open Source BioPerl, BioPython and Biojava projects provide toolkits with multiple functionality that make it easier to create customised pipelines or analysis. This review briefly compares the quirks of the underlying languages and the functionality, documentation, utility and relative advantages of the Bio counterparts, particularly from the point of view of the beginning biologist programmer.'

The key names used in a Medline record can be rather obscure; use

In [39]:
help(record)
Help on Record in module Bio.Medline object:

class Record(builtins.dict)
 |  A dictionary holding information from a Medline record.
 |
 |  All data are stored under the mnemonic appearing in the Medline
 |  file. These mnemonics have the following interpretations:
 |
 |  ========= ==============================
 |  Mnemonic  Description
 |  --------- ------------------------------
 |  AB        Abstract
 |  CI        Copyright Information
 |  AD        Affiliation
 |  IRAD      Investigator Affiliation
 |  AID       Article Identifier
 |  AU        Author
 |  FAU       Full Author
 |  CN        Corporate Author
 |  DCOM      Date Completed
 |  DA        Date Created
 |  LR        Date Last Revised
 |  DEP       Date of Electronic Publication
 |  DP        Date of Publication
 |  EDAT      Entrez Date
 |  GS        Gene Symbol
 |  GN        General Note
 |  GR        Grant Number
 |  IR        Investigator Name
 |  FIR       Full Investigator Name
 |  IS        ISSN
 |  IP        Issue
 |  TA        Journal Title Abbreviation
 |  JT        Journal Title
 |  LA        Language
 |  LID       Location Identifier
 |  MID       Manuscript Identifier
 |  MHDA      MeSH Date
 |  MH        MeSH Terms
 |  JID       NLM Unique ID
 |  RF        Number of References
 |  OAB       Other Abstract
 |  OCI       Other Copyright Information
 |  OID       Other ID
 |  OT        Other Term
 |  OTO       Other Term Owner
 |  OWN       Owner
 |  PG        Pagination
 |  PS        Personal Name as Subject
 |  FPS       Full Personal Name as Subject
 |  PL        Place of Publication
 |  PHST      Publication History Status
 |  PST       Publication Status
 |  PT        Publication Type
 |  PUBM      Publishing Model
 |  PMC       PubMed Central Identifier
 |  PMID      PubMed Unique Identifier
 |  RN        Registry Number/EC Number
 |  NM        Substance Name
 |  SI        Secondary Source ID
 |  SO        Source
 |  SFM       Space Flight Mission
 |  STAT      Status
 |  SB        Subset
 |  TI        Title
 |  TT        Transliterated Title
 |  VI        Volume
 |  CON       Comment on
 |  CIN       Comment in
 |  EIN       Erratum in
 |  EFR       Erratum for
 |  CRI       Corrected and Republished in
 |  CRF       Corrected and Republished from
 |  PRIN      Partial retraction in
 |  PROF      Partial retraction of
 |  RPI       Republished in
 |  RPF       Republished from
 |  RIN       Retraction in
 |  ROF       Retraction of
 |  UIN       Update in
 |  UOF       Update of
 |  SPIN      Summary for patients in
 |  ORI       Original report in
 |  ========= ==============================
 |
 |  Method resolution order:
 |      Record
 |      builtins.dict
 |      builtins.object
 |
 |  Data descriptors defined here:
 |
 |  __dict__
 |      dictionary for instance variables (if defined)
 |
 |  __weakref__
 |      list of weak references to the object (if defined)
 |
 |  ----------------------------------------------------------------------
 |  Methods inherited from builtins.dict:
 |
 |  __contains__(self, key, /)
 |      True if D has a key k, else False.
 |
 |  __delitem__(self, key, /)
 |      Delete self[key].
 |
 |  __eq__(self, value, /)
 |      Return self==value.
 |
 |  __ge__(self, value, /)
 |      Return self>=value.
 |
 |  __getattribute__(self, name, /)
 |      Return getattr(self, name).
 |
 |  __getitem__(...)
 |      x.__getitem__(y) <==> x[y]
 |
 |  __gt__(self, value, /)
 |      Return self>value.
 |
 |  __init__(self, /, *args, **kwargs)
 |      Initialize self.  See help(type(self)) for accurate signature.
 |
 |  __iter__(self, /)
 |      Implement iter(self).
 |
 |  __le__(self, value, /)
 |      Return self<=value.
 |
 |  __len__(self, /)
 |      Return len(self).
 |
 |  __lt__(self, value, /)
 |      Return self<value.
 |
 |  __ne__(self, value, /)
 |      Return self!=value.
 |
 |  __new__(*args, **kwargs) from builtins.type
 |      Create and return a new object.  See help(type) for accurate signature.
 |
 |  __repr__(self, /)
 |      Return repr(self).
 |
 |  __setitem__(self, key, value, /)
 |      Set self[key] to value.
 |
 |  __sizeof__(...)
 |      D.__sizeof__() -> size of D in memory, in bytes
 |
 |  clear(...)
 |      D.clear() -> None.  Remove all items from D.
 |
 |  copy(...)
 |      D.copy() -> a shallow copy of D
 |
 |  fromkeys(iterable, value=None, /) from builtins.type
 |      Returns a new dict with keys from iterable and values equal to value.
 |
 |  get(...)
 |      D.get(k[,d]) -> D[k] if k in D, else d.  d defaults to None.
 |
 |  items(...)
 |      D.items() -> a set-like object providing a view on D's items
 |
 |  keys(...)
 |      D.keys() -> a set-like object providing a view on D's keys
 |
 |  pop(...)
 |      D.pop(k[,d]) -> v, remove specified key and return the corresponding value.
 |      If key is not found, d is returned if given, otherwise KeyError is raised
 |
 |  popitem(...)
 |      D.popitem() -> (k, v), remove and return some (key, value) pair as a
 |      2-tuple; but raise KeyError if D is empty.
 |
 |  setdefault(...)
 |      D.setdefault(k[,d]) -> D.get(k,d), also set D[k]=d if k not in D
 |
 |  update(...)
 |      D.update([E, ]**F) -> None.  Update D from dict/iterable E and F.
 |      If E is present and has a .keys() method, then does:  for k in E: D[k] = E[k]
 |      If E is present and lacks a .keys() method, then does:  for k, v in E: D[k] = v
 |      In either case, this is followed by: for k in F:  D[k] = F[k]
 |
 |  values(...)
 |      D.values() -> an object providing a view on D's values
 |
 |  ----------------------------------------------------------------------
 |  Data and other attributes inherited from builtins.dict:
 |
 |  __hash__ = None

for a brief summary.

To parse a file containing multiple Medline records, you can use the parse function instead:

In [40]:
from Bio import Medline
with open("data/pubmed_result2.txt") as handle:
    for record in Medline.parse(handle):
        print(record["TI"])
A high level interface to SCOP and ASTRAL implemented in python.
GenomeDiagram: a python package for the visualization of large-scale genomic data.
Open source clustering software.
PDB file parser and structure class implemented in Python.

Instead of parsing Medline records stored in files, you can also parse Medline records downloaded by Bio.Entrez.efetch. For example, let’s look at all Medline records in PubMed related to Biopython:

In [41]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.esearch(db="pubmed", term="biopython")
record = Entrez.read(handle)
record["IdList"]
Out[41]:
['24929426', '24497503', '24267035', '24194598', '23842806', '23157543', '22909249', '22399473', '21666252', '21210977', '20015970', '19811691', '19773334', '19304878', '18606172', '21585724', '16403221', '16377612', '14871861', '14630660']

We now use Bio.Entrez.efetch to download these Medline records:

In [42]:
idlist = record["IdList"]
handle = Entrez.efetch(db="pubmed", id=idlist, rettype="medline", retmode="text")

Here, we specify rettype="medline", retmode="text" to obtain the Medline records in plain-text Medline format. Now we use Bio.Medline to parse these records:

In [43]:
from Bio import Medline
records = Medline.parse(handle)
for record in records:
    print(record["AU"])
['Waldmann J', 'Gerken J', 'Hankeln W', 'Schweer T', 'Glockner FO']
['Mielke CJ', 'Mandarino LJ', 'Dinu V']
['Gajda MJ']
['Mathelier A', 'Zhao X', 'Zhang AW', 'Parcy F', 'Worsley-Hunt R', 'Arenillas DJ', 'Buchman S', 'Chen CY', 'Chou A', 'Ienasescu H', 'Lim J', 'Shyr C', 'Tan G', 'Zhou M', 'Lenhard B', 'Sandelin A', 'Wasserman WW']
['Morales HF', 'Giovambattista G']
['Baldwin S', 'Revanna R', 'Thomson S', 'Pither-Joyce M', 'Wright K', 'Crowhurst R', 'Fiers M', 'Chen L', 'Macknight R', 'McCallum JA']
['Talevich E', 'Invergo BM', 'Cock PJ', 'Chapman BA']
['Prins P', 'Goto N', 'Yates A', 'Gautier L', 'Willis S', 'Fields C', 'Katayama T']
['Schmitt T', 'Messina DN', 'Schreiber F', 'Sonnhammer EL']
['Antao T']
['Cock PJ', 'Fields CJ', 'Goto N', 'Heuer ML', 'Rice PM']
['Jankun-Kelly TJ', 'Lindeman AD', 'Bridges SM']
['Korhonen J', 'Martinmaki P', 'Pizzi C', 'Rastas P', 'Ukkonen E']
['Cock PJ', 'Antao T', 'Chang JT', 'Chapman BA', 'Cox CJ', 'Dalke A', 'Friedberg I', 'Hamelryck T', 'Kauff F', 'Wilczynski B', 'de Hoon MJ']
['Munteanu CR', 'Gonzalez-Diaz H', 'Magalhaes AL']
['Faircloth BC']
['Casbon JA', 'Crooks GE', 'Saqi MA']
['Pritchard L', 'White JA', 'Birch PR', 'Toth IK']
['de Hoon MJ', 'Imoto S', 'Nolan J', 'Miyano S']
['Hamelryck T', 'Manderick B']

For comparison, here we show an example using the XML format:

In [44]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.esearch(db="pubmed", term="biopython")
record = Entrez.read(handle)
idlist = record["IdList"]
handle = Entrez.efetch(db="pubmed", id=idlist, rettype="medline", retmode="xml")
records = Entrez.read(handle)
for record in records:
    print(record["MedlineCitation"]["Article"]["ArticleTitle"])
FastaValidator: an open-source Java library to parse and validate FASTA formatted sequences.
AMASS: a database for investigating protein structures.
HPDB-Haskell library for processing atomic biomolecular structures in Protein Data Bank format.
JASPAR 2014: an extensively expanded and updated open-access database of transcription factor binding profiles.
BioSmalltalk: a pure object system and library for bioinformatics.
A toolkit for bulk PCR-based marker design from next-generation sequence data: application for development of a framework linkage map in bulb onion (Allium cepa L.).
Bio.Phylo: a unified toolkit for processing, analyzing and visualizing phylogenetic trees in Biopython.
Sharing programming resources between Bio* projects through remote procedure call and native call stack strategies.
Letter to the editor: SeqXML and OrthoXML: standards for sequence and orthology information.
interPopula: a Python API to access the HapMap Project dataset.
The Sanger FASTQ file format for sequences with quality scores, and the Solexa/Illumina FASTQ variants.
Exploratory visual analysis of conserved domains on multiple sequence alignments.
MOODS: fast search for position weight matrix matches in DNA sequences.
Biopython: freely available Python tools for computational molecular biology and bioinformatics.
Enzymes/non-enzymes classification model complexity based on composition, sequence, 3D and topological indices.
msatcommander: detection of microsatellite repeat arrays and automated, locus-specific primer design.
A high level interface to SCOP and ASTRAL implemented in python.
GenomeDiagram: a python package for the visualization of large-scale genomic data.
Open source clustering software.
PDB file parser and structure class implemented in Python.

Note that in both of these examples, for simplicity we have naively combined ESearch and EFetch. In this situation, the NCBI would expect you to use their history feature, as illustrated in Section History and WebEnv.

Parsing GEO records

GEO (Gene Expression Omnibus) is a data repository of high-throughput gene expression and hybridization array data. The Bio.Geo module can be used to parse GEO-formatted data.

The following code fragment shows how to parse the example GEO file GSE16.txt into a record and print the record:

In [45]:
from Bio import Geo
handle = open("data/GSE16.txt")
records = Geo.parse(handle)
for record in records:
    print(record)
GEO Type: SAMPLE
GEO Id: GSM804
Sample_author: Antoine,M,Snijders

Sample_author: Norma,,Nowak

Sample_author: Richard,,Segraves

Sample_author: Stephanie,,Blackwood

Sample_author: Nils,,Brown

Sample_author: Jeffery,,Conroy

Sample_author: Greg,,Hamilton

Sample_author: Anna,K,Hindle

Sample_author: Bing,,Huey

Sample_author: Karen,,Kimura

Sample_author: Sindy,,Law

Sample_author: Ken,,Myambo

Sample_author: Joel,,Palmer

Sample_author: Bauke,,Ylstra

Sample_author: Jingzhu,P,Yue

Sample_author: Joe,W,Gray

Sample_author: Ajay,N,Jain

Sample_author: Daniel,,Pinkel

Sample_author: Donna,G,Albertson

Sample_description: Coriell Cell Repositories cell line <a h
ref="http://locus.umdnj.edu/nigms/nigms_cgi/display.cgi?GM05296">GM05296</a>.

Sample_description: Fibroblast cell line derived from a 1 mo
nth old female with multiple congenital malformations, dysmorphic features, intr
auterine growth retardation, heart murmur, cleft palate, equinovarus deformity,
microcephaly, coloboma of right iris, clinodactyly, reduced RBC catalase activit
y, and 1 copy of catalase gene.

Sample_description: Chromosome abnormalities are present.

Sample_description: Karyotype is 46,XX,-11,+der(11)inv ins(1
1;10)(11pter> 11p13::10q21>10q24::11p13>11qter)mat

Sample_organism: Homo sapiens

Sample_platform_id: GPL28

Sample_pubmed_id: 11687795

Sample_series_id: GSE16

Sample_status: Public on Feb 12 2002

Sample_submission_date: Jan 17 2002

Sample_submitter_city: San Francisco,CA,94143,USA

Sample_submitter_department: Comprehensive Cancer Center

Sample_submitter_email: albertson@cc.ucsf.edu

Sample_submitter_institute: University of California San Francisco

Sample_submitter_name: Donna,G,Albertson

Sample_submitter_phone: 415 502-8463

Sample_target_source1: Cell line GM05296

Sample_target_source2: normal male reference genomic DNA

Sample_title: CGH_Albertson_GM05296-001218

Sample_type: dual channel genomic

Column Header Definitions
    ID_REF: Unique row identifier, genome position o
    rder

    LINEAR_RATIO: Mean of replicate Cy3/Cy5 ratios

    LOG2STDDEV: Standard deviation of VALUE

    NO_REPLICATES: Number of replicate spot measurements

    VALUE: aka LOG2RATIO, mean of log base 2 of LIN
    EAR_RATIO

0: ID_REF       VALUE   LINEAR_RATIO    LOG2STDDEV      NO_REPLICATES
1: 1            1.047765        0.011853        3
2: 2                            0
3: 3    0.008824        1.006135        0.00143 3
4: 4    -0.000894       0.99938 0.001454        3
5: 5    0.075875        1.054   0.003077        3
6: 6    0.017303        1.012066        0.005876        2
7: 7    -0.006766       0.995321        0.013881        3
8: 8    0.020755        1.014491        0.005506        3
9: 9    -0.094938       0.936313        0.012662        3
10: 10  -0.054527       0.96291 0.01073 3
11: 11  -0.025057       0.982782        0.003855        3
12: 12                          0
13: 13  0.108454        1.078072        0.005196        3
14: 14  0.078633        1.056017        0.009165        3
15: 15  0.098571        1.070712        0.007834        3
16: 16  0.044048        1.031003        0.013651        3
17: 17  0.018039        1.012582        0.005471        3
18: 18  -0.088807       0.9403  0.010571        3
19: 19  0.016349        1.011397        0.007113        3
20: 20  0.030977        1.021704        0.016798        3

You can search the “gds” database (GEO datasets) with ESearch:

In [46]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com" # Always tell NCBI who you are
handle = Entrez.esearch(db="gds", term="GSE16")
record = Entrez.read(handle)
record["Count"]
Out[46]:
'27'
In [47]:
record["IdList"]
Out[47]:
['200000016', '100000028', '300000818', '300000817', '300000816', '300000815', '300000814', '300000813', '300000812', '300000811', '300000810', '300000809', '300000808', '300000807', '300000806', '300000805', '300000804', '300000803', '300000802', '300000801']

From the Entrez website, UID “200000016” is GDS16 while the other hit “100000028” is for the associated platform, GPL28. Unfortunately, at the time of writing the NCBI don’t seem to support downloading GEO files using Entrez (not as XML, nor in the Simple Omnibus Format in Text (SOFT) format).

However, it is actually pretty straight forward to download the GEO files by FTP or HTTP from http://ftp.ncbi.nih.gov/pub/geo/ instead. In this case you might want http://ftp.ncbi.nih.gov/pub/geo/DATA/SOFT/by_series/GSE16/GSE16_family.soft.gz (a compressed file, see the Python module gzip).

Parsing UniGene records

UniGene is an NCBI database of the transcriptome, with each UniGene record showing the set of transcripts that are associated with a particular gene in a specific organism. A typical UniGene record looks like this:

ID          Hs.2
TITLE       N-acetyltransferase 2 (arylamine N-acetyltransferase)
GENE        NAT2
CYTOBAND    8p22
GENE_ID     10
LOCUSLINK   10
HOMOL       YES
EXPRESS      bone| connective tissue| intestine| liver| liver tumor| normal| soft tissue/muscle tissue tumor| adult
RESTR_EXPR   adult
CHROMOSOME  8
STS         ACC=PMC310725P3 UNISTS=272646
STS         ACC=WIAF-2120 UNISTS=44576
STS         ACC=G59899 UNISTS=137181
...
STS         ACC=GDB:187676 UNISTS=155563
PROTSIM     ORG=10090; PROTGI=6754794; PROTID=NP_035004.1; PCT=76.55; ALN=288
PROTSIM     ORG=9796; PROTGI=149742490; PROTID=XP_001487907.1; PCT=79.66; ALN=288
PROTSIM     ORG=9986; PROTGI=126722851; PROTID=NP_001075655.1; PCT=76.90; ALN=288
...
PROTSIM     ORG=9598; PROTGI=114619004; PROTID=XP_519631.2; PCT=98.28; ALN=288

SCOUNT      38
SEQUENCE    ACC=BC067218.1; NID=g45501306; PID=g45501307; SEQTYPE=mRNA
SEQUENCE    ACC=NM_000015.2; NID=g116295259; PID=g116295260; SEQTYPE=mRNA
SEQUENCE    ACC=D90042.1; NID=g219415; PID=g219416; SEQTYPE=mRNA
SEQUENCE    ACC=D90040.1; NID=g219411; PID=g219412; SEQTYPE=mRNA
SEQUENCE    ACC=BC015878.1; NID=g16198419; PID=g16198420; SEQTYPE=mRNA
SEQUENCE    ACC=CR407631.1; NID=g47115198; PID=g47115199; SEQTYPE=mRNA
SEQUENCE    ACC=BG569293.1; NID=g13576946; CLONE=IMAGE:4722596; END=5'; LID=6989; SEQTYPE=EST; TRACE=44157214
...
SEQUENCE    ACC=AU099534.1; NID=g13550663; CLONE=HSI08034; END=5'; LID=8800; SEQTYPE=EST
//

This particular record shows the set of transcripts (shown in the SEQUENCE lines) that originate from the human gene NAT2, encoding en N-acetyltransferase. The PROTSIM lines show proteins with significant similarity to NAT2, whereas the STS lines show the corresponding sequence-tagged sites in the genome.

To parse UniGene files, use the Bio.UniGene module:

TODO: Need a working example

In [48]:
# from Bio import UniGene
# input = open("data/myunigenefile.data")
# record = UniGene.read(input)

The record returned by UniGene.read is a Python object with attributes corresponding to the fields in the UniGene record. For example,

In [49]:
# record.ID
In [50]:
# record.title

The EXPRESS and RESTR_EXPR lines are stored as Python lists of strings:

['bone', 'connective tissue', 'intestine', 'liver', 'liver tumor', 'normal', 'soft tissue/muscle tissue tumor', 'adult']

Specialized objects are returned for the STS, PROTSIM, and SEQUENCE lines, storing the keys shown in each line as attributes:

In [51]:
# record.sts[0].acc
In [52]:
# record.sts[0].unists

and similarly for the PROTSIM and SEQUENCE lines.

To parse a file containing more than one UniGene record, use the parse function in Bio.UniGene:

TODO: Need a working example

In [53]:
# from Bio import UniGene
# input = open("unigenerecords.data")
# records = UniGene.parse(input)
# for record in records:
#     print(record.ID)

Using a proxy

Normally you won’t have to worry about using a proxy, but if this is an issue on your network here is how to deal with it. Internally, Bio.Entrez uses the standard Python library urllib for accessing the NCBI servers. This will check an environment variable called http_proxy to configure any simple proxy automatically. Unfortunately this module does not support the use of proxies which require authentication.

You may choose to set the http_proxy environment variable once (how you do this will depend on your operating system). Alternatively you can set this within Python at the start of your script, for example:

import os
os.environ["http_proxy"] = "http://proxyhost.example.com:8080"

See the urllib documentation for more details.

Examples

PubMed and Medline

If you are in the medical field or interested in human issues (and many times even if you are not!), PubMed (http://www.ncbi.nlm.nih.gov/PubMed/) is an excellent source of all kinds of goodies. So like other things, we’d like to be able to grab information from it and use it in Python scripts.

In this example, we will query PubMed for all articles having to do with orchids (see section [sec:orchids] for our motivation). We first check how many of such articles there are:

In [54]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.egquery(term="orchid")
record = Entrez.read(handle)
for row in record["eGQueryResult"]:
    if row["DbName"]=="pubmed":
        print(row["Count"])
1376

Now we use the Bio.Entrez.efetch function to download the PubMed IDs of these 463 articles:

In [55]:
handle = Entrez.esearch(db="pubmed", term="orchid", retmax=463)
record = Entrez.read(handle)
idlist = record["IdList"]
print("The first 10 Id's containing all of the PubMed IDs of articles related to orchids:\n {}".format(idlist[:10]))
The first 10 Id's containing all of the PubMed IDs of articles related to orchids:
 ['26752741', '26743923', '26738548', '26732875', '26732614', '26724929', '26715121', '26713612', '26708054', '26694378']

Now that we’ve got them, we obviously want to get the corresponding Medline records and extract the information from them. Here, we’ll download the Medline records in the Medline flat-file format, and use the Bio.Medline module to parse them:

In [56]:
from Bio import Medline
handle = Entrez.efetch(db="pubmed", id=idlist, rettype="medline")
In [57]:
records = Medline.parse(handle)

NOTE - We’ve just done a separate search and fetch here, the NCBI much prefer you to take advantage of their history support in this situation. See Section History and WebEnv.

Keep in mind that records is an iterator, so you can iterate through the records only once. If you want to save the records, you can convert them to a list:

In [58]:
records = list(records)

Let’s now iterate over the records to print out some information about each record:

In [59]:
for record in records:
    print("title:", record.get("TI", "?"))
    print("authors:", record.get("AU", "?"))
    print("source:", record.get("SO", "?"))
    print("")

title: Promise and Challenge of DNA Barcoding in Venus Slipper (Paphiopedilum).
authors: ['Guo YY', 'Huang LQ', 'Liu ZJ', 'Wang XQ']
source: PLoS One. 2016 Jan 11;11(1):e0146880. doi: 10.1371/journal.pone.0146880. eCollection 2016.

title: In vitro profiling of anti-MRSA activity of thymoquinone against selected type and clinical strains.
authors: ['Hariharan P', 'Paul-Satyaseela M', 'Gnanamani A']
source: Lett Appl Microbiol. 2016 Jan 7. doi: 10.1111/lam.12544.

title: Low glutathione redox state couples with a decreased ascorbate redox ratio to accelerate flowering in Oncidium orchid.
authors: ['Chin DC', 'Hsieh CC', 'Lin HY', 'Yeh KW']
source: Plant Cell Physiol. 2016 Jan 6. pii: pcv206.

title: Proteomic and morphometric study of the in vitro interaction between Oncidium sphacelatum Lindl. (Orchidaceae) and Thanatephorus sp. RG26 (Ceratobasidiaceae).
authors: ['Lopez-Chavez MY', 'Guillen-Navarro K', 'Bertolini V', 'Encarnacion S', 'Hernandez-Ortiz M', 'Sanchez-Moreno I', 'Damon A']
source: Mycorrhiza. 2016 Jan 6.

title: A transcriptome-wide, organ-specific regulatory map of Dendrobium officinale, an important traditional Chinese orchid herb.
authors: ['Meng Y', 'Yu D', 'Xue J', 'Lu J', 'Feng S', 'Shen C', 'Wang H']
source: Sci Rep. 2016 Jan 6;6:18864. doi: 10.1038/srep18864.

title: Methods for genetic transformation in Dendrobium.
authors: ['Teixeira da Silva JA', 'Dobranszki J', 'Cardoso JC', 'Chandler SF', 'Zeng S']
source: Plant Cell Rep. 2016 Jan 2.

title: Sebacina vermifera: a unique root symbiont with vast agronomic potential.
authors: ['Ray P', 'Craven KD']
source: World J Microbiol Biotechnol. 2016 Jan;32(1):16. doi: 10.1007/s11274-015-1970-7. Epub 2015 Dec 29.

title: Cuticular Hydrocarbons of Orchid Bees Males: Interspecific and Chemotaxonomy Variation.
authors: ['Dos Santos AB', 'do Nascimento FS']
source: PLoS One. 2015 Dec 29;10(12):e0145070. doi: 10.1371/journal.pone.0145070. eCollection 2015.

title: Sex and the Catasetinae (Darwin's favourite orchids).
authors: ['Perez-Escobar OA', 'Gottschling M', 'Whitten WM', 'Salazar G', 'Gerlach G']
source: Mol Phylogenet Evol. 2015 Dec 17. pii: S1055-7903(15)00372-3. doi: 10.1016/j.ympev.2015.11.019.

title: Comparative Transcriptome Analysis of Genes Involved in GA-GID1-DELLA Regulatory Module in Symbiotic and Asymbiotic Seed Germination of Anoectochilus roxburghii (Wall.) Lindl. (Orchidaceae).
authors: ['Liu SS', 'Chen J', 'Li SC', 'Zeng X', 'Meng ZX', 'Guo SX']
source: Int J Mol Sci. 2015 Dec 18;16(12):30190-203. doi: 10.3390/ijms161226224.

title: Dual Drug Loaded Nanoliposomal Chemotherapy: A Promising Strategy for Treatment of Head and Neck Squamous Cell Carcinoma.
authors: ['Mohan A', 'Narayanan S', 'Balasubramanian G', 'Sethuraman S', 'Krishnan UM']
source: Eur J Pharm Biopharm. 2015 Dec 9. pii: S0939-6411(15)00489-0. doi: 10.1016/j.ejpb.2015.11.017.

title: Orally available stilbene derivatives as potent HDAC inhibitors with antiproliferative activities and antitumor effects in human tumor xenografts.
authors: ['Kachhadia V', 'Rajagopal S', 'Ponpandian T', 'Vignesh R', 'Anandhan K', 'Prabhu D', 'Rajendran P', 'Nidhyanandan S', 'Roy AM', 'Ahamed FA', 'Surendran N', 'Rajagopal S', 'Narayanan S', 'Gopalan B']
source: Eur J Med Chem. 2015 Nov 19;108:274-286. doi: 10.1016/j.ejmech.2015.11.014.

title: Parapheromones for Thynnine Wasps.
authors: ['Bohman B', 'Karton A', 'Dixon RC', 'Barrow RA', 'Peakall R']
source: J Chem Ecol. 2015 Dec 14.

title: Interaction networks and the use of floral resources by male orchid bees (Hymenoptera: Apidae: Euglossini) in a primary rain forests of the Choco Region (Colombia).
authors: ['Ospina-Torres R', 'Montoya-Pfeiffer PM', 'Parra-H A', 'Solarte V', 'Tupac Otero J']
source: Rev Biol Trop. 2015 Sep;63(3):647-58.

title: A taste of pineapple evolution through genome sequencing.
authors: ['Xu Q', 'Liu ZJ']
source: Nat Genet. 2015 Dec 1;47(12):1374-6. doi: 10.1038/ng.3450.

title: Somatic Embryogenesis in Two Orchid Genera (Cymbidium, Dendrobium).
authors: ['Teixeira da Silva JA', 'Winarto B']
source: Methods Mol Biol. 2016;1359:371-86. doi: 10.1007/978-1-4939-3061-6_18.

title: Tumors of the Testis: Morphologic Features and Molecular Alterations.
authors: ['Howitt BE', 'Berney DM']
source: Surg Pathol Clin. 2015 Dec;8(4):687-716. doi: 10.1016/j.path.2015.07.007.

title: Scent emission profiles from Darwin's orchid - Angraecum sesquipedale: Investigation of the aldoxime metabolism using clustering analysis.
authors: ['Nielsen LJ', 'Moller BL']
source: Phytochemistry. 2015 Dec;120:3-18. doi: 10.1016/j.phytochem.2015.10.004. Epub 2015 Oct 22.

title: Two common species dominate the species-rich Euglossine bee fauna of an Atlantic Rainforest remnant in Pernambuco, Brazil.
authors: ['Oliveira R', 'Pinto CE', 'Schlindwein C']
source: Braz J Biol. 2015 Nov;75(4 Suppl 1):1-8. doi: 10.1590/1519-6984.18513. Epub 2015 Nov 24.

title: Variation in the Abundance of Neotropical Bees in an Unpredictable Seasonal Environment.
authors: ['Knoll FR']
source: Neotrop Entomol. 2015 Nov 23.

title: Digital Gene Expression Analysis Based on De Novo Transcriptome Assembly Reveals New Genes Associated with Floral Organ Differentiation of the Orchid Plant Cymbidium ensifolium.
authors: ['Yang F', 'Zhu G']
source: PLoS One. 2015 Nov 18;10(11):e0142434. doi: 10.1371/journal.pone.0142434. eCollection 2015.

title: LONG-TERM CONSERVATION OF PROTOCORMS OF Brassavola nodosa (L) LIND. (ORCHIDACEAE): EFFECT OF ABA AND A RANGE OF CRYOCONSERVATION TECHNIQUES.
authors: ['Mata-Rosas M', 'Lastre-Puertos E']
source: Cryo Letters. 2015 Sep-Oct;36(5):289-98.

title: Cuticular Hydrocarbons as Potential Close Range Recognition Cues in Orchid Bees.
authors: ['Pokorny T', 'Ramirez SR', 'Weber MG', 'Eltz T']
source: J Chem Ecol. 2015 Dec;41(12):1080-94. doi: 10.1007/s10886-015-0647-x. Epub 2015 Nov 14.

title: Bilobate leaves of Bauhinia (Leguminosae, Caesalpinioideae, Cercideae) from the middle Miocene of Fujian Province, southeastern China and their biogeographic implications.
authors: ['Lin Y', 'Wong WO', 'Shi G', 'Shen S', 'Li Z']
source: BMC Evol Biol. 2015 Nov 16;15(1):252. doi: 10.1186/s12862-015-0540-9.

title: Functional Significance of Labellum Pattern Variation in a Sexually Deceptive Orchid (Ophrys heldreichii): Evidence of Individual Signature Learning Effects.
authors: ['Stejskal K', 'Streinzer M', 'Dyer A', 'Paulus HF', 'Spaethe J']
source: PLoS One. 2015 Nov 16;10(11):e0142971. doi: 10.1371/journal.pone.0142971. eCollection 2015.

title: Centralization of cleft care in the UK. Part 6: a tale of two studies.
authors: ['Ness AR', 'Wills AK', 'Waylen A', 'Al-Ghatam R', 'Jones TE', 'Preston R', 'Ireland AJ', 'Persson M', 'Smallridge J', 'Hall AJ', 'Sell D', 'Sandy JR']
source: Orthod Craniofac Res. 2015 Nov;18 Suppl 2:56-62. doi: 10.1111/ocr.12111.

title: The Cleft Care UK study. Part 4: perceptual speech outcomes.
authors: ['Sell D', 'Mildinhall S', 'Albery L', 'Wills AK', 'Sandy JR', 'Ness AR']
source: Orthod Craniofac Res. 2015 Nov;18 Suppl 2:36-46. doi: 10.1111/ocr.12112.

title: A cross-sectional survey of 5-year-old children with non-syndromic unilateral cleft lip and palate: the Cleft Care UK study. Part 1: background and methodology.
authors: ['Persson M', 'Sandy JR', 'Waylen A', 'Wills AK', 'Al-Ghatam R', 'Ireland AJ', 'Hall AJ', 'Hollingworth W', 'Jones T', 'Peters TJ', 'Preston R', 'Sell D', 'Smallridge J', 'Worthington H', 'Ness AR']
source: Orthod Craniofac Res. 2015 Nov;18 Suppl 2:1-13. doi: 10.1111/ocr.12104.

title: Seven New Complete Plastome Sequences Reveal Rampant Independent Loss of the ndh Gene Family across Orchids and Associated Instability of the Inverted Repeat/Small Single-Copy Region Boundaries.
authors: ['Kim HT', 'Kim JS', 'Moore MJ', 'Neubig KM', 'Williams NH', 'Whitten WM', 'Kim JH']
source: PLoS One. 2015 Nov 11;10(11):e0142215. doi: 10.1371/journal.pone.0142215. eCollection 2015.

title: Orchid Species Richness along Elevational and Environmental Gradients in Yunnan, China.
authors: ['Zhang SB', 'Chen WY', 'Huang JL', 'Bi YF', 'Yang XF']
source: PLoS One. 2015 Nov 10;10(11):e0142621. doi: 10.1371/journal.pone.0142621. eCollection 2015.

title: Severe outbreeding and inbreeding depression maintain mating system differentiation in Epipactis (Orchidaceae).
authors: ['Brys R', 'Jacquemyn H']
source: J Evol Biol. 2015 Nov 9. doi: 10.1111/jeb.12787.

title: Simultaneous detection of Cymbidium mosaic virus and Odontoglossum ringspot virus in orchids using multiplex RT-PCR.
authors: ['Kim SM', 'Choi SH']
source: Virus Genes. 2015 Dec;51(3):417-22. doi: 10.1007/s11262-015-1258-x. Epub 2015 Nov 5.

title: Analysis of the TCP genes expressed in the inflorescence of the orchid Orchis italica.
authors: ['De Paolo S', 'Gaudio L', 'Aceto S']
source: Sci Rep. 2015 Nov 4;5:16265. doi: 10.1038/srep16265.

title: RNA-Seq SSRs of Moth Orchid and Screening for Molecular Markers across Genus Phalaenopsis (Orchidaceae).
authors: ['Tsai CC', 'Shih HC', 'Wang HV', 'Lin YS', 'Chang CH', 'Chiang YC', 'Chou CH']
source: PLoS One. 2015 Nov 2;10(11):e0141761. doi: 10.1371/journal.pone.0141761. eCollection 2015.

title: Mapping Adolescent Cancer Services: How Do Young People, Their Families, and Staff Describe Specialized Cancer Care in England?
authors: ['Vindrola-Padros C', 'Taylor RM', 'Lea S', 'Hooker L', 'Pearce S', 'Whelan J', 'Gibson F']
source: Cancer Nurs. 2015 Oct 28.

title: A putative miR172-targeted CeAPETALA2-like gene is involved in floral patterning regulation of the orchid Cymbidium ensifolium.
authors: ['Yang FX', 'Zhu GF', 'Wang Z', 'Liu HL', 'Huang D']
source: Genet Mol Res. 2015 Oct 5;14(4):12049-61. doi: 10.4238/2015.October.5.18.

title: Functional Characterization of PhapLEAFY, a FLORICAULA/LEAFY Ortholog in Phalaenopsis aphrodite.
authors: ['Jang S']
source: Plant Cell Physiol. 2015 Nov;56(11):2234-47. doi: 10.1093/pcp/pcv130. Epub 2015 Oct 22.

title: Evolutionary history of PEPC genes in green plants: Implications for the evolution of CAM in orchids.
authors: ['Deng H', 'Zhang LS', 'Zhang GQ', 'Zheng BQ', 'Liu ZJ', 'Wang Y']
source: Mol Phylogenet Evol. 2016 Jan;94(Pt B):559-64. doi: 10.1016/j.ympev.2015.10.007. Epub 2015 Oct 19.

title: Three new alkaloids and three new phenolic glycosides from Liparis odorata.
authors: ['Jiang P', 'Liu H', 'Xu X', 'Liu B', 'Zhang D', 'Lai X', 'Zhu G', 'Xu P', 'Li B']
source: Fitoterapia. 2015 Dec;107:63-8. doi: 10.1016/j.fitote.2015.10.003. Epub 2015 Oct 19.

title: Microsatellite-based genetic diversity patterns in disjunct populations of a rare orchid.
authors: ['Pandey M', 'Richards M', 'Sharma J']
source: Genetica. 2015 Oct 20.

title: Effects of fusaric acid treatment on the protocorm-like bodies of Dendrobium sonia-28.
authors: ['Dehgahi R', 'Zakaria L', 'Mohamad A', 'Joniyas A', 'Subramaniam S']
source: Protoplasma. 2015 Oct 15.

title: Genes are information, so information theory is coming to the aid of evolutionary biology.
authors: ['Sherwin WB']
source: Mol Ecol Resour. 2015 Nov;15(6):1259-61. doi: 10.1111/1755-0998.12458.

title: A Comprehensive Review of the Cosmeceutical Benefits of Vanda Species (Orchidaceae).
authors: ['Hadi H', 'Razali SN', 'Awadh AI']
source: Nat Prod Commun. 2015 Aug;10(8):1483-8.

title: The C-Terminal Sequence and PI motif of the Orchid (Oncidium Gower Ramsey) PISTILLATA (PI) Ortholog Determine its Ability to Bind AP3 Orthologs and Enter the Nucleus to Regulate Downstream Genes Controlling Petal and Stamen Formation.
authors: ['Mao WT', 'Hsu HF', 'Hsu WH', 'Li JY', 'Lee YI', 'Yang CH']
source: Plant Cell Physiol. 2015 Nov;56(11):2079-99. doi: 10.1093/pcp/pcv129. Epub 2015 Sep 30.

title: Alternative translation initiation codons for the plastid maturase MatK: unraveling the pseudogene misconception in the Orchidaceae.
authors: ['Barthet MM', 'Moukarzel K', 'Smith KN', 'Patel J', 'Hilu KW']
source: BMC Evol Biol. 2015 Sep 29;15:210. doi: 10.1186/s12862-015-0491-1.

title: A dual functional probe for "turn-on" fluorescence response of Pb(2+) and colorimetric detection of Cu(2+) based on a rhodamine derivative in aqueous media.
authors: ['Li M', 'Jiang XJ', 'Wu HH', 'Lu HL', 'Li HY', 'Xu H', 'Zang SQ', 'Mak TC']
source: Dalton Trans. 2015 Oct 21;44(39):17326-34. doi: 10.1039/c5dt02731d. Epub 2015 Sep 21.

title: Mining from transcriptomes: 315 single-copy orthologous genes concatenated for the phylogenetic analyses of Orchidaceae.
authors: ['Deng H', 'Zhang GQ', 'Lin M', 'Wang Y', 'Liu ZJ']
source: Ecol Evol. 2015 Sep;5(17):3800-7. doi: 10.1002/ece3.1642. Epub 2015 Aug 20.

title: Orchid conservation in the biodiversity hotspot of southwestern China.
authors: ['Liu Q', 'Chen J', 'Corlett RT', 'Fan X', 'Yu D', 'Yang H', 'Gao J']
source: Conserv Biol. 2015 Sep 15. doi: 10.1111/cobi.12584.

title: Biochemical characterization of embryogenic calli of Vanilla planifolia in response to two years of thidiazuron treatment.
authors: ['Kodja H', 'Noirot M', 'Khoyratty SS', 'Limbada H', 'Verpoorte R', 'Palama TL']
source: Plant Physiol Biochem. 2015 Nov;96:337-44. doi: 10.1016/j.plaphy.2015.08.017. Epub 2015 Aug 28.

title: Vanda roxburghii: an experimental evaluation of antinociceptive properties of a traditional epiphytic medicinal orchid in animal models.
authors: ['Uddin MJ', 'Rahman MM', 'Abdullah-Al-Mamun M', 'Sadik G']
source: BMC Complement Altern Med. 2015 Sep 3;15:305. doi: 10.1186/s12906-015-0833-y.

title: Rapid evolution of chemosensory receptor genes in a pair of sibling species of orchid bees (Apidae: Euglossini).
authors: ['Brand P', 'Ramirez SR', 'Leese F', 'Quezada-Euan JJ', 'Tollrian R', 'Eltz T']
source: BMC Evol Biol. 2015 Aug 28;15:176. doi: 10.1186/s12862-015-0451-9.

title: Changes in Orchid Bee Communities Across Forest-Agroecosystem Boundaries in Brazilian Atlantic Forest Landscapes.
authors: ['Aguiar WM', 'Sofia SH', 'Melo GA', 'Gaglianone MC']
source: Environ Entomol. 2015 Dec;44(6):1465-71. doi: 10.1093/ee/nvv130. Epub 2015 Aug 11.

title: Orchid conservation: making the links.
authors: ['Fay MF', 'Pailler T', 'Dixon KW']
source: Ann Bot. 2015 Sep;116(3):377-9. doi: 10.1093/aob/mcv142.

title: Orchid phylogenomics and multiple drivers of their extraordinary diversification.
authors: ['Givnish TJ', 'Spalink D', 'Ames M', 'Lyon SP', 'Hunter SJ', 'Zuluaga A', 'Iles WJ', 'Clements MA', 'Arroyo MT', 'Leebens-Mack J', 'Endara L', 'Kriebel R', 'Neubig KM', 'Whitten WM', 'Williams NH', 'Cameron KM']
source: Proc Biol Sci. 2015 Sep 7;282(1814). doi: 10.1098/rspb.2015.1553.

title: Photoprotection related to xanthophyll cycle pigments in epiphytic orchids acclimated at different light microenvironments in two tropical dry forests of the Yucatan Peninsula, Mexico.
authors: ['de la Rosa-Manzano E', 'Andrade JL', 'Garcia-Mendoza E', 'Zotz G', 'Reyes-Garcia C']
source: Planta. 2015 Dec;242(6):1425-38. doi: 10.1007/s00425-015-2383-4. Epub 2015 Aug 25.

title: Mycorrhizal fungi isolated from native terrestrial orchids of pristine regions in Cordoba (Argentina).
authors: ['Fernandez Di Pardo A', 'Chiocchio VM', 'Barrera V', 'Colombo RP', 'Martinez AE', 'Gasoni L', 'Godeas AM']
source: Rev Biol Trop. 2015 Mar;63(1):275-83.

title: Orchid-pollinator interactions and potential vulnerability to biological invasion.
authors: ['Chupp AD', 'Battaglia LL', 'Schauber EM', 'Sipes SD']
source: AoB Plants. 2015 Aug 17;7. pii: plv099. doi: 10.1093/aobpla/plv099.

title: Germination and seedling establishment in orchids: a complex of requirements.
authors: ['Rasmussen HN', 'Dixon KW', 'Jersakova J', 'Tesitelova T']
source: Ann Bot. 2015 Sep;116(3):391-402. doi: 10.1093/aob/mcv087. Epub 2015 Aug 12.

title: Capsule formation and asymbiotic seed germination in some hybrids of Phalaenopsis, influenced by pollination season and capsule maturity.
authors: ['Balilashaki K', 'Gantait S', 'Naderi R', 'Vahedi M']
source: Physiol Mol Biol Plants. 2015 Jul;21(3):341-7. doi: 10.1007/s12298-015-0309-z. Epub 2015 Jul 7.

title: dsRNA silencing of an R2R3-MYB transcription factor affects flower cell shape in a Dendrobium hybrid.
authors: ['Lau SE', 'Schwarzacher T', 'Othman RY', 'Harikrishna JA']
source: BMC Plant Biol. 2015 Aug 11;15:194. doi: 10.1186/s12870-015-0577-3.

title: Clinical and echocardiographic characteristics for differentiating between transthyretin-related and light-chain cardiac amyloidoses.
authors: ['Mori M', 'An Y', 'Katayama O', 'Kitagawa T', 'Sasaki Y', 'Onaka T', 'Yonezawa A', 'Murata K', 'Yokota T', 'Ando K', 'Imada K']
source: Ann Hematol. 2015 Nov;94(11):1885-90. doi: 10.1007/s00277-015-2466-0. Epub 2015 Aug 8.

title: First record of the orchid bee genus Eufriesea Cockerell (Hymenoptera: Apidae: Euglossini) in the United States.
authors: ['Griswold T', 'Herndon JD', 'Gonzalez VH']
source: Zootaxa. 2015 May 15;3957(3):342-6. doi: 10.11646/zootaxa.3957.3.7.

title: Thuniopsis: A New Orchid Genus and Phylogeny of the Tribe Arethuseae (Orchidaceae).
authors: ['Li L', 'Ye DP', 'Niu M', 'Yan HF', 'Wen TL', 'Li SJ']
source: PLoS One. 2015 Aug 5;10(8):e0132777. doi: 10.1371/journal.pone.0132777. eCollection 2015.

title: Additive effects of pollinators and herbivores result in both conflicting and reinforcing selection on floral traits.
authors: ['Sletvold N', 'Moritz KK', 'Agren J']
source: Ecology. 2015 Jan;96(1):214-21.

title: Terrestrial orchids in a tropical forest: best sites for abundance differ from those for reproduction.
authors: ['Whitman M', 'Ackerman JD']
source: Ecology. 2015 Mar;96(3):693-704.

title: Spiranthes sinensis Suppresses Production of Pro-Inflammatory Mediators by Down-Regulating the NF-kappaB Signaling Pathway and Up-Regulating HO-1/Nrf2 Anti-Oxidant Protein.
authors: ['Shie PH', 'Huang SS', 'Deng JS', 'Huang GJ']
source: Am J Chin Med. 2015;43(5):969-89. doi: 10.1142/S0192415X15500561. Epub 2015 Jul 30.

title: Phosphodiesterase inhibitor, pentoxifylline enhances anticancer activity of histone deacetylase inhibitor, MS-275 in human breast cancer in vitro and in vivo.
authors: ['Nidhyanandan S', 'Boreddy TS', 'Chandrasekhar KB', 'Reddy ND', 'Kulkarni NM', 'Narayanan S']
source: Eur J Pharmacol. 2015 Oct 5;764:508-19. doi: 10.1016/j.ejphar.2015.07.048. Epub 2015 Jul 21.

title: The effects of smoke derivatives on in vitro seed germination and development of the leopard orchid Ansellia africana.
authors: ['Papenfus HB', 'Naidoo D', 'Posta M', 'Finnie JF', 'Van Staden J']
source: Plant Biol (Stuttg). 2015 Jul 23. doi: 10.1111/plb.12374.

title: DhEFL2, 3 and 4, the three EARLY FLOWERING4-like genes in a Doritaenopsis hybrid regulate floral transition.
authors: ['Chen W', 'Qin Q', 'Zhang C', 'Zheng Y', 'Wang C', 'Zhou M', 'Cui Y']
source: Plant Cell Rep. 2015 Dec;34(12):2027-41. doi: 10.1007/s00299-015-1848-z. Epub 2015 Jul 24.

title: Spatial variation in pollinator-mediated selection on phenology, floral display and spur length in the orchid Gymnadenia conopsea.
authors: ['Chapurlat E', 'Agren J', 'Sletvold N']
source: New Phytol. 2015 Dec;208(4):1264-75. doi: 10.1111/nph.13555. Epub 2015 Jul 15.

title: Building the Evidence for Nursing Practice: Learning from a Structured Review of SIOP Abstracts, 2003-2012.
authors: ['Gibson F', 'Vindrola-Padros C', 'Hinds P', 'Nolbris MJ', 'Kelly D', 'Kelly P', 'Ruccione K', 'Soanes L', 'Woodgate RL', 'Baggott C']
source: Pediatr Blood Cancer. 2015 Dec;62(12):2172-6. doi: 10.1002/pbc.25652. Epub 2015 Jul 14.

title: Genetic variability within and among populations of an invasive, exotic orchid.
authors: ['Ueno S', 'Rodrigues JF', 'Alves-Pereira A', 'Pansarin ER', 'Veasey EA']
source: AoB Plants. 2015 Jul 10;7. pii: plv077. doi: 10.1093/aobpla/plv077.

title: Hydrolysis of clavulanate by Mycobacterium tuberculosis beta-lactamase BlaC harboring a canonical SDN motif.
authors: ['Soroka D', 'Li de la Sierra-Gallay I', 'Dubee V', 'Triboulet S', 'van Tilbeurgh H', 'Compain F', 'Ballell L', 'Barros D', 'Mainardi JL', 'Hugonnet JE', 'Arthur M']
source: Antimicrob Agents Chemother. 2015 Sep;59(9):5714-20. doi: 10.1128/AAC.00598-15. Epub 2015 Jul 6.

title: Experimental fertilization increases amino acid content in floral nectar, fruit set and degree of selfing in the orchid Gymnadenia conopsea.
authors: ['Gijbels P', 'Ceulemans T', 'Van den Ende W', 'Honnay O']
source: Oecologia. 2015 Nov;179(3):785-95. doi: 10.1007/s00442-015-3381-8. Epub 2015 Jul 7.

title: Seasonal cycles, phylogenetic assembly, and functional diversity of orchid bee communities.
authors: ['Ramirez SR', 'Hernandez C', 'Link A', 'Lopez-Uribe MM']
source: Ecol Evol. 2015 May;5(9):1896-907. doi: 10.1002/ece3.1466. Epub 2015 Apr 13.

title: Migration of nonylphenol from food-grade plastic is toxic to the coral reef fish species Pseudochromis fridmani.
authors: ['Hamlin HJ', 'Marciano K', 'Downs CA']
source: Chemosphere. 2015 Nov;139:223-8. doi: 10.1016/j.chemosphere.2015.06.032. Epub 2015 Jun 29.

title: Responses to simulated nitrogen deposition by the neotropical epiphytic orchid Laelia speciosa.
authors: ['Diaz-Alvarez EA', 'Lindig-Cisneros R', 'de la Barrera E']
source: PeerJ. 2015 Jun 23;3:e1021. doi: 10.7717/peerj.1021. eCollection 2015.

title: Applicability of ISSR and DAMD markers for phyto-molecular characterization and association with some important biochemical traits of Dendrobium nobile, an endangered medicinal orchid.
authors: ['Bhattacharyya P', 'Kumaria S', 'Tandon P']
source: Phytochemistry. 2015 Sep;117:306-16. doi: 10.1016/j.phytochem.2015.06.022. Epub 2015 Jun 27.

title: The importance of associations with saprotrophic non-Rhizoctonia fungi among fully mycoheterotrophic orchids is currently under-estimated: novel evidence from sub-tropical Asia.
authors: ['Lee YI', 'Yang CK', 'Gebauer G']
source: Ann Bot. 2015 Sep;116(3):423-35. doi: 10.1093/aob/mcv085. Epub 2015 Jun 25.

title: Continent-wide distribution in mycorrhizal fungi: implications for the biogeography of specialized orchids.
authors: ['Davis BJ', 'Phillips RD', 'Wright M', 'Linde CC', 'Dixon KW']
source: Ann Bot. 2015 Sep;116(3):413-21. doi: 10.1093/aob/mcv084. Epub 2015 Jun 22.

title: Dynamic distribution and the role of abscisic acid during seed development of a lady's slipper orchid, Cypripedium formosanum.
authors: ['Lee YI', 'Chung MC', 'Yeung EC', 'Lee N']
source: Ann Bot. 2015 Sep;116(3):403-11. doi: 10.1093/aob/mcv079. Epub 2015 Jun 22.

title: Characterization of microsatellite loci for an Australian epiphytic orchid, Dendrobium calamiforme, using Illumina sequencing.
authors: ['Trapnell DW', 'Beasley RR', 'Lance SL', 'Field AR', 'Jones KL']
source: Appl Plant Sci. 2015 Jun 5;3(6). pii: apps.1500016. doi: 10.3732/apps.1500016. eCollection 2015 Jun.

title: Factors affecting reproductive success in three entomophilous orchid species in Hungary.
authors: ['Vojtko AE', 'Sonkoly J', 'Lukacs BA', 'Molnar V A']
source: Acta Biol Hung. 2015 Jun;66(2):231-41. doi: 10.1556/018.66.2015.2.9.

title: Pollination by sexual deception promotes outcrossing and mate diversity in self-compatible clonal orchids.
authors: ['Whitehead MR', 'Linde CC', 'Peakall R']
source: J Evol Biol. 2015 Aug;28(8):1526-41. doi: 10.1111/jeb.12673. Epub 2015 Jul 3.

title: Adding Biotic Interactions into Paleodistribution Models: A Host-Cleptoparasite Complex of Neotropical Orchid Bees.
authors: ['Silva DP', 'Varela S', 'Nemesio A', 'De Marco P Jr']
source: PLoS One. 2015 Jun 12;10(6):e0129890. doi: 10.1371/journal.pone.0129890. eCollection 2015.

title: Mapping of the Interaction Between Agrobacterium tumefaciens and Vanda Kasem's Delight Orchid Protocorm-Like Bodies.
authors: ['Gnasekaran P', 'Subramaniam S']
source: Indian J Microbiol. 2015 Sep;55(3):285-91. doi: 10.1007/s12088-015-0519-7. Epub 2015 Feb 25.

title: Spatial asymmetries in connectivity influence colonization-extinction dynamics.
authors: ['Acevedo MA', 'Fletcher RJ Jr', 'Tremblay RL', 'Melendez-Ackerman EJ']
source: Oecologia. 2015 Oct;179(2):415-24. doi: 10.1007/s00442-015-3361-z. Epub 2015 Jun 10.

title: Dendrobium micropropagation: a review.
authors: ['da Silva JA', 'Cardoso JC', 'Dobranszki J', 'Zeng S']
source: Plant Cell Rep. 2015 May;34(5):671-704.

title: Crystal structure of 2-(4-fluoro-3-methyl-phen-yl)-5-{[(naphthalen-1-yl)-oxy]meth-yl}-1,3,4-oxa-diazol e.
authors: ['Govindhan M', 'Subramanian K', 'Viswanathan V', 'Velmurugan D']
source: Acta Crystallogr E Crystallogr Commun. 2015 Mar 11;71(Pt 4):o229-30. doi: 10.1107/S2056989015004144. eCollection 2015 Apr 1.

title: Cymbidium chlorotic mosaic virus, a new sobemovirus isolated from a spring orchid (Cymbidium goeringii) in Japan.
authors: ['Kondo H', 'Takemoto S', 'Maruyama K', 'Chiba S', 'Andika IB', 'Suzuki N']
source: Arch Virol. 2015 Aug;160(8):2099-104. doi: 10.1007/s00705-015-2460-9. Epub 2015 May 31.

title: Effect of pesticide exposure on immunological, hematological and biochemical parameters in thai orchid farmers- a cross-sectional study.
authors: ['Aroonvilairat S', 'Kespichayawattana W', 'Sornprachum T', 'Chaisuriya P', 'Siwadune T', 'Ratanabanangkoon K']
source: Int J Environ Res Public Health. 2015 May 27;12(6):5846-61. doi: 10.3390/ijerph120605846.

title: Phylogeny and classification of the East Asian Amitostigma alliance (Orchidaceae: Orchideae) based on six DNA markers.
authors: ['Tang Y', 'Yukawa T', 'Bateman RM', 'Jiang H', 'Peng H']
source: BMC Evol Biol. 2015 May 26;15:96. doi: 10.1186/s12862-015-0376-3.

title: Combinations of beta-Lactam Antibiotics Currently in Clinical Trials Are Efficacious in a DHP-I-Deficient Mouse Model of Tuberculosis Infection.
authors: ['Rullas J', 'Dhar N', 'McKinney JD', 'Garcia-Perez A', 'Lelievre J', 'Diacon AH', 'Hugonnet JE', 'Arthur M', 'Angulo-Barturen I', 'Barros-Aguirre D', 'Ballell L']
source: Antimicrob Agents Chemother. 2015 Aug;59(8):4997-9. doi: 10.1128/AAC.01063-15. Epub 2015 May 18.

title: A de novo floral transcriptome reveals clues into Phalaenopsis orchid flower development.
authors: ['Huang JZ', 'Lin CP', 'Cheng TC', 'Chang BC', 'Cheng SY', 'Chen YW', 'Lee CY', 'Chin SW', 'Chen FC']
source: PLoS One. 2015 May 13;10(5):e0123474. doi: 10.1371/journal.pone.0123474. eCollection 2015.

title: Mycorrhizal diversity, seed germination and long-term changes in population size across nine populations of the terrestrial orchid Neottia ovata.
authors: ['Jacquemyn H', 'Waud M', 'Merckx VS', 'Lievens B', 'Brys R']
source: Mol Ecol. 2015 Jul;24(13):3269-80. doi: 10.1111/mec.13236. Epub 2015 Jun 5.

title: Potential osteogenic activity of ethanolic extract and oxoflavidin isolated from Pholidota articulata Lindley.
authors: ['Sharma C', 'Dixit M', 'Singh R', 'Agrawal M', 'Mansoori MN', 'Kureel J', 'Singh D', 'Narender T', 'Arya KR']
source: J Ethnopharmacol. 2015 Jul 21;170:57-65. doi: 10.1016/j.jep.2015.04.045. Epub 2015 May 8.

title: Transitions between self-compatibility and self-incompatibility and the evolution of reproductive isolation in the large and diverse tropical genus Dendrobium (Orchidaceae).
authors: ['Pinheiro F', 'Cafasso D', 'Cozzolino S', 'Scopece G']
source: Ann Bot. 2015 Sep;116(3):457-67. doi: 10.1093/aob/mcv057. Epub 2015 May 7.

title: A new species of Cnemaspis (Sauria: Gekkonidae) from Northern Karnataka, India.
authors: ['Srinivasulu C', 'Kumar GC', 'Srinivasulu B']
source: Zootaxa. 2015 Apr 14;3947(1):85-98. doi: 10.11646/zootaxa.3947.1.5.

title: Visual profile of students in integrated schools in Malawi.
authors: ['Kaphle D', 'Marasini S', 'Kalua K', 'Reading A', 'Naidoo KS']
source: Clin Exp Optom. 2015 Jul;98(4):370-4. doi: 10.1111/cxo.12269. Epub 2015 May 5.

title: A direct assessment of realized seed and pollen flow within and between two isolated populations of the food-deceptive orchid Orchis mascula.
authors: ['Helsen K', 'Meekers T', 'Vranckx G', 'Roldan-Ruiz I', 'Vandepitte K', 'Honnay O']
source: Plant Biol (Stuttg). 2015 May 4. doi: 10.1111/plb.12342.

title: Challenges of flow-cytometric estimation of nuclear genome size in orchids, a plant group with both whole-genome and progressively partial endoreplication.
authors: ['Travnicek P', 'Ponert J', 'Urfus T', 'Jersakova J', 'Vrana J', 'Hribova E', 'Dolezel J', 'Suda J']
source: Cytometry A. 2015 Oct;87(10):958-66. doi: 10.1002/cyto.a.22681. Epub 2015 Apr 30.

title: Transcriptome-wide analysis of the MADS-box gene family in the orchid Erycina pusilla.
authors: ['Lin CS', 'Hsu CT', 'Liao C', 'Chang WJ', 'Chou ML', 'Huang YT', 'Chen JJ', 'Ko SS', 'Chan MT', 'Shih MC']
source: Plant Biotechnol J. 2015 Apr 28. doi: 10.1111/pbi.12383.

title: An informational diversity framework, illustrated with sexually deceptive orchids in early stages of speciation.
authors: ['Smouse PE', 'Whitehead MR', 'Peakall R']
source: Mol Ecol Resour. 2015 Nov;15(6):1375-84. doi: 10.1111/1755-0998.12422. Epub 2015 May 20.

title: A new myco-heterotrophic genus, Yunorchis, and the molecular phylogenetic relationships of the tribe Calypsoeae (Epidendroideae, Orchidaceae) inferred from plastid and nuclear DNA sequences.
authors: ['Zhang GQ', 'Li MH', 'Su YY', 'Chen LJ', 'Lan SR', 'Liu ZJ']
source: PLoS One. 2015 Apr 22;10(4):e0123382. doi: 10.1371/journal.pone.0123382. eCollection 2015.

title: Phylogenetic placement and taxonomy of the genus Hederorkis (Orchidaceae).
authors: ['Mytnik-Ejsmont J', 'Szlachetko DL', 'Baranow P', 'Jolliffe K', 'Gorniak M']
source: PLoS One. 2015 Apr 22;10(4):e0122306. doi: 10.1371/journal.pone.0122306. eCollection 2015.

title: Species distribution modelling for conservation of an endangered endemic orchid.
authors: ['Wang HH', 'Wonkka CL', 'Treglia ML', 'Grant WE', 'Smeins FE', 'Rogers WE']
source: AoB Plants. 2015 Apr 21;7. pii: plv039. doi: 10.1093/aobpla/plv039.

title: Floral miniaturisation and autogamy in boreal-arctic plants are epitomised by Iceland's most frequent orchid, Platanthera hyperborea.
authors: ['Bateman RM', 'Sramko G', 'Rudall PJ']
source: PeerJ. 2015 Apr 14;3:e894. doi: 10.7717/peerj.894. eCollection 2015.

title: Highly diversified fungi are associated with the achlorophyllous orchid Gastrodia flavilabella.
authors: ['Liu T', 'Li CM', 'Han YL', 'Chiang TY', 'Chiang YC', 'Sung HM']
source: BMC Genomics. 2015 Mar 14;16:185. doi: 10.1186/s12864-015-1422-7.

title: Floral nectary anatomy and ultrastructure in mycoheterotrophic plant, Epipogium aphyllum Sw. (Orchidaceae).
authors: ['Swieczkowska E', 'Kowalkowska AK']
source: ScientificWorldJournal. 2015;2015:201702. doi: 10.1155/2015/201702. Epub 2015 Mar 25.

title: The complete chloroplast genome sequence of Anoectochilus roxburghii.
authors: ['Yu CW', 'Lian Q', 'Wu KC', 'Yu SH', 'Xie LY', 'Wu ZJ']
source: Mitochondrial DNA. 2015 Apr 13:1-2.

title: Effects of droplet-vitrification cryopreservation based on physiological and antioxidant enzyme activities of Brassidium shooting star orchid.
authors: ['Rahmah S', 'Ahmad Mubbarakh S', 'Soo Ping K', 'Subramaniam S']
source: ScientificWorldJournal. 2015;2015:961793. doi: 10.1155/2015/961793. Epub 2015 Mar 11.

title: Pollinator behaviour on a food-deceptive orchid Calypso bulbosa and coflowering species.
authors: ['Tuomi J', 'Lamsa J', 'Wannas L', 'Abeli T', 'Jakalaniemi A']
source: ScientificWorldJournal. 2015;2015:482161. doi: 10.1155/2015/482161. Epub 2015 Mar 12.

title: Reticulate evolution and sea-level fluctuations together drove species diversification of slipper orchids (Paphiopedilum) in South-East Asia.
authors: ['Guo YY', 'Luo YB', 'Liu ZJ', 'Wang XQ']
source: Mol Ecol. 2015 Jun;24(11):2838-55. doi: 10.1111/mec.13189. Epub 2015 May 7.

title: Crystal structure of 2-{[(naphthalen-1-yl)oxy]meth-yl}-5-(2,4,5-tri-fluoro-phen-yl)-1,3,4-oxa-diazole.
authors: ['Govindhan M', 'Subramanian K', 'Viswanathan V', 'Velmurugan D']
source: Acta Crystallogr E Crystallogr Commun. 2015 Feb 21;71(Pt 3):o190-1. doi: 10.1107/S2056989015003205. eCollection 2015 Mar 1.

title: The effect of mealybug Pseudococcus longispinus (Targioni Tozzetti) infestation of different density on physiological responses of Phalaenopsis x hybridum 'Innocence'.
authors: ['Kot I', 'Kmiec K', 'Gorska-Drabik E', 'Golan K', 'Rubinowska K', 'Lagowska B']
source: Bull Entomol Res. 2015 Jun;105(3):373-80. doi: 10.1017/S000748531500022X. Epub 2015 Apr 1.

title: The Genome of Dendrobium officinale Illuminates the Biology of the Important Traditional Chinese Orchid Herb.
authors: ['Yan L', 'Wang X', 'Liu H', 'Tian Y', 'Lian J', 'Yang R', 'Hao S', 'Wang X', 'Yang S', 'Li Q', 'Qi S', 'Kui L', 'Okpekum M', 'Ma X', 'Zhang J', 'Ding Z', 'Zhang G', 'Wang W', 'Dong Y', 'Sheng J']
source: Mol Plant. 2015 Jun;8(6):922-34. doi: 10.1016/j.molp.2014.12.011. Epub 2014 Dec 24.

title: Recurrent polymorphic mating type variation in Madagascan species (Orchidaceae) exemplifies a high incidence of auto-pollination in tropical orchids.
authors: ['Gamisch A', 'Fischer GA', 'Comes HP']
source: Bot J Linn Soc. 2014 Jun;175(2):242-258. Epub 2014 May 20.

title: When stable-stage equilibrium is unlikely: integrating transient population dynamics improves asymptotic methods.
authors: ['Tremblay RL', 'Raventos J', 'Ackerman JD']
source: Ann Bot. 2015 Sep;116(3):381-90. doi: 10.1093/aob/mcv031. Epub 2015 Mar 26.

title: Antibiotic susceptibility pattern of Enterobacteriaceae and non-fermenter Gram-negative clinical isolates of microbial resource orchid.
authors: ['Hariharan P', 'Bharani T', 'Franklyne JS', 'Biswas P', 'Solanki SS', 'Paul-Satyaseela M']
source: J Nat Sci Biol Med. 2015 Jan-Jun;6(1):198-201. doi: 10.4103/0976-9668.149121.

title: Pollination system and the effect of inflorescence size on fruit set in the deceptive orchid Cephalanthera falcata.
authors: ['Suetsugu K', 'Naito RS', 'Fukushima S', 'Kawakita A', 'Kato M']
source: J Plant Res. 2015 Jul;128(4):585-94. doi: 10.1007/s10265-015-0716-9. Epub 2015 Mar 24.

title: Polysaccharide hydrogel combined with mesenchymal stem cells promotes the healing of corneal alkali burn in rats.
authors: ['Ke Y', 'Wu Y', 'Cui X', 'Liu X', 'Yu M', 'Yang C', 'Li X']
source: PLoS One. 2015 Mar 19;10(3):e0119725. doi: 10.1371/journal.pone.0119725. eCollection 2015.

title: Ex situ germination as a method for seed viability assessment in a peatland orchid, Platanthera blephariglottis.
authors: ['Lemay MA', 'De Vriendt L', 'Pellerin S', 'Poulin M']
source: Am J Bot. 2015 Mar;102(3):390-5. doi: 10.3732/ajb.1400441. Epub 2015 Mar 1.

title: Preliminary findings on identification of mycorrhizal fungi from diverse orchids in the Central Highlands of Madagascar.
authors: ['Yokoya K', 'Zettler LW', 'Kendon JP', 'Bidartondo MI', 'Stice AL', 'Skarha S', 'Corey LL', 'Knight AC', 'Sarasan V']
source: Mycorrhiza. 2015 Nov;25(8):611-25. doi: 10.1007/s00572-015-0635-6. Epub 2015 Mar 14.

title: Pollination biology in the dioecious orchid Catasetum uncatum: How does floral scent influence the behaviour of pollinators?
authors: ['Milet-Pinheiro P', 'Navarro DM', 'Dotterl S', 'Carvalho AT', 'Pinto CE', 'Ayasse M', 'Schlindwein C']
source: Phytochemistry. 2015 Aug;116:149-61. doi: 10.1016/j.phytochem.2015.02.027. Epub 2015 Mar 11.

title: The location and translocation of ndh genes of chloroplast origin in the Orchidaceae family.
authors: ['Lin CS', 'Chen JJ', 'Huang YT', 'Chan MT', 'Daniell H', 'Chang WJ', 'Hsu CT', 'Liao DC', 'Wu FH', 'Lin SY', 'Liao CF', 'Deyholos MK', 'Wong GK', 'Albert VA', 'Chou ML', 'Chen CY', 'Shih MC']
source: Sci Rep. 2015 Mar 12;5:9040. doi: 10.1038/srep09040.

title: Genetic structure is associated with phenotypic divergence in floral traits and reproductive investment in a high-altitude orchid from the Iron Quadrangle, southeastern Brazil.
authors: ['Leles B', 'Chaves AV', 'Russo P', 'Batista JA', 'Lovato MB']
source: PLoS One. 2015 Mar 10;10(3):e0120645. doi: 10.1371/journal.pone.0120645. eCollection 2015.

title: A molecular phylogeny of Aeridinae (Orchidaceae: Epidendroideae) inferred from multiple nuclear and chloroplast regions.
authors: ['Zou LH', 'Huang JX', 'Zhang GQ', 'Liu ZJ', 'Zhuang XY']
source: Mol Phylogenet Evol. 2015 Apr;85:247-54. doi: 10.1016/j.ympev.2015.02.014. Epub 2015 Feb 26.

title: Corrigendum: The genome sequence of the orchid Phalaenopsis equestris.
authors: ['Cai J', 'Liu X', 'Vanneste K', 'Proost S', 'Tsai WC', 'Liu KW', 'Chen LJ', 'He Y', 'Xu Q', 'Bian C', 'Zheng Z', 'Sun F', 'Liu W', 'Hsiao YY', 'Pan ZJ', 'Hsu CC', 'Yang YP', 'Hsu YC', 'Chuang YC', 'Dievart A', 'Dufayard JF', 'Xu X', 'Wang JY', 'Wang J', 'Xiao XJ', 'Zhao XM', 'Du R', 'Zhang GQ', 'Wang M', 'Su YY', 'Xie GC', 'Liu GH', 'Li LQ', 'Huang LQ', 'Luo YB', 'Chen HH', 'Van de Peer Y', 'Liu ZJ']
source: Nat Genet. 2015 Mar;47(3):304. doi: 10.1038/ng0315-304a.

title: Convergent losses of decay mechanisms and rapid turnover of symbiosis genes in mycorrhizal mutualists.
authors: ['Kohler A', 'Kuo A', 'Nagy LG', 'Morin E', 'Barry KW', 'Buscot F', 'Canback B', 'Choi C', 'Cichocki N', 'Clum A', 'Colpaert J', 'Copeland A', 'Costa MD', 'Dore J', 'Floudas D', 'Gay G', 'Girlanda M', 'Henrissat B', 'Herrmann S', 'Hess J', 'Hogberg N', 'Johansson T', 'Khouja HR', 'LaButti K', 'Lahrmann U', 'Levasseur A', 'Lindquist EA', 'Lipzen A', 'Marmeisse R', 'Martino E', 'Murat C', 'Ngan CY', 'Nehls U', 'Plett JM', 'Pringle A', 'Ohm RA', 'Perotto S', 'Peter M', 'Riley R', 'Rineau F', 'Ruytinx J', 'Salamov A', 'Shah F', 'Sun H', 'Tarkka M', 'Tritt A', 'Veneault-Fourrey C', 'Zuccaro A', 'Tunlid A', 'Grigoriev IV', 'Hibbett DS', 'Martin F']
source: Nat Genet. 2015 Apr;47(4):410-5. doi: 10.1038/ng.3223. Epub 2015 Feb 23.

title: Chemical and morphological filters in a specialized floral mimicry system.
authors: ['Martos F', 'Cariou ML', 'Pailler T', 'Fournel J', 'Bytebier B', 'Johnson SD']
source: New Phytol. 2015 Jul;207(1):225-34. doi: 10.1111/nph.13350. Epub 2015 Feb 20.

title: Modeling the two-locus architecture of divergent pollinator adaptation: how variation in SAD paralogs affects fitness and evolutionary divergence in sexually deceptive orchids.
authors: ['Xu S', 'Schluter PM']
source: Ecol Evol. 2015 Jan;5(2):493-502. doi: 10.1002/ece3.1378. Epub 2015 Jan 4.

title: Pollination ecology of two species of Elleanthus (Orchidaceae): novel mechanisms and underlying adaptations to hummingbird pollination.
authors: ['Nunes CE', 'Amorim FW', 'Mayer JL', 'Sazima M']
source: Plant Biol (Stuttg). 2015 Feb 11. doi: 10.1111/plb.12312.

title: Sequential decarboxylative azide-alkyne cycloaddition and dehydrogenative coupling reactions: one-pot synthesis of polycyclic fused triazoles.
authors: ['Bharathimohan K', 'Ponpandian T', 'Ahamed AJ', 'Bhuvanesh N']
source: Beilstein J Org Chem. 2014 Dec 17;10:3031-7. doi: 10.3762/bjoc.10.321. eCollection 2014.

title: Are tetraploids more successful? Floral signals, reproductive success and floral isolation in mixed-ploidy populations of a terrestrial orchid.
authors: ['Gross K', 'Schiestl FP']
source: Ann Bot. 2015 Feb;115(2):263-73. doi: 10.1093/aob/mcu244.

title: Setting the pace of life: membrane composition of flight muscle varies with metabolic rate of hovering orchid bees.
authors: ['Rodriguez E', 'Weber JM', 'Page B', 'Roubik DW', 'Suarez RK', 'Darveau CA']
source: Proc Biol Sci. 2015 Mar 7;282(1802). pii: 20142232. doi: 10.1098/rspb.2014.2232.

title: Mycorrhizal ecology and evolution: the past, the present, and the future.
authors: ['van der Heijden MG', 'Martin FM', 'Selosse MA', 'Sanders IR']
source: New Phytol. 2015 Mar;205(4):1406-23. doi: 10.1111/nph.13288. Epub 2015 Feb 2.

title: The orchid-bee fauna (Hymenoptera: Apidae) of a forest remnant in the southern portion of the Brazilian Amazon.
authors: ['Santos Junior JE', 'Ferrari RR', 'Nemesio A']
source: Braz J Biol. 2014 Aug;74(3 Suppl 1):S184-90. doi: 10.1590/1519-6984.25712.

title: Is the "Centro de Endemismo Pernambuco" a biodiversity hotspot for orchid bees?
authors: ['Nemesio A', 'Santos Junior JE']
source: Braz J Biol. 2014 Aug;74(3 Suppl 1):S78-92. doi: 10.1590/1519-6984.26412.

title: Sampling a biodiversity hotspot: the orchid-bee fauna (Hymenoptera: Apidae) of Tarapoto, northeastern Peru, the richest and most diverse site of the Neotropics.
authors: ['Nemesio A', 'Rasmussen C']
source: Braz J Biol. 2014 Aug;74(3 Suppl 1):S33-44. doi: 10.1590/1519-6984.20412.

title: Mismatch in the distribution of floral ecotypes and pollinators: insights into the evolution of sexually deceptive orchids.
authors: ['Phillips RD', 'Bohman B', 'Anthony JM', 'Krauss SL', 'Dixon KW', 'Peakall R']
source: J Evol Biol. 2015 Mar;28(3):601-12. doi: 10.1111/jeb.12593. Epub 2015 Feb 20.

title: Mycorrhizal networks and coexistence in species-rich orchid communities.
authors: ['Jacquemyn H', 'Brys R', 'Waud M', 'Busschaert P', 'Lievens B']
source: New Phytol. 2015 May;206(3):1127-34. doi: 10.1111/nph.13281. Epub 2015 Jan 23.

title: Two widespread green Neottia species (Orchidaceae) show mycorrhizal preference for Sebacinales in various habitats and ontogenetic stages.
authors: ['Tesitelova T', 'Kotilinek M', 'Jersakova J', 'Joly FX', 'Kosnar J', 'Tatarenko I', 'Selosse MA']
source: Mol Ecol. 2015 Mar;24(5):1122-34. doi: 10.1111/mec.13088. Epub 2015 Feb 16.

title: Genetic stability and phytochemical analysis of the in vitro regenerated plants of Dendrobium nobile Lindl., an endangered medicinal orchid.
authors: ['Bhattacharyya P', 'Kumaria S', 'Diengdoh R', 'Tandon P']
source: Meta Gene. 2014 Jul 15;2:489-504. doi: 10.1016/j.mgene.2014.06.003. eCollection 2014 Dec.

title: Complete chloroplast genome of the orchid Cattleya crispata (Orchidaceae:Laeliinae), a Neotropical rupiculous species.
authors: ['da Rocha Perini V', 'Leles B', 'Furtado C', 'Prosdocimi F']
source: Mitochondrial DNA. 2015 Jan 20:1-3.

title: RNA/DNA co-analysis from human skin and contact traces--results of a sixth collaborative EDNAP exercise.
authors: ['Haas C', 'Hanson E', 'Banemann R', 'Bento AM', 'Berti A', 'Carracedo A', 'Courts C', 'De Cock G', 'Drobnic K', 'Fleming R', 'Franchi C', 'Gomes I', 'Hadzic G', 'Harbison SA', 'Hjort B', 'Hollard C', 'Hoff-Olsen P', 'Keyser C', 'Kondili A', 'Maronas O', 'McCallum N', 'Miniati P', 'Morling N', 'Niederstatter H', 'Noel F', 'Parson W', 'Porto MJ', 'Roeder AD', 'Sauer E', 'Schneider PM', 'Shanthan G', 'Sijen T', 'Syndercombe Court D', 'Turanska M', 'van den Berge M', 'Vennemann M', 'Vidaki A', 'Zatkalikova L', 'Ballantyne J']
source: Forensic Sci Int Genet. 2015 May;16:139-47. doi: 10.1016/j.fsigen.2015.01.002. Epub 2015 Jan 7.

title: Ethylene and pollination decrease transcript abundance of an ethylene receptor gene in Dendrobium petals.
authors: ['Thongkum M', 'Burns P', 'Bhunchoth A', 'Warin N', 'Chatchawankanphanich O', 'van Doorn WG']
source: J Plant Physiol. 2015 Mar 15;176:96-100. doi: 10.1016/j.jplph.2014.12.008. Epub 2014 Dec 18.

title: Pollen limitation and the contribution of autonomous selfing to fruit and seed set in a rewarding orchid.
authors: ['Jacquemyn H', 'Brys R']
source: Am J Bot. 2015 Jan;102(1):67-72. doi: 10.3732/ajb.1400449. Epub 2014 Dec 22.

title: In vitro propagation of Paphiopedilum orchids.
authors: ['Zeng S', 'Huang W', 'Wu K', 'Zhang J', 'Teixeira da Silva JA', 'Duan J']
source: Crit Rev Biotechnol. 2015 Sep 11:1-14.

title: Vanillin-bioconversion and bioengineering of the most popular plant flavor and its de novo biosynthesis in the vanilla orchid.
authors: ['Gallage NJ', 'Moller BL']
source: Mol Plant. 2015 Jan;8(1):40-57. doi: 10.1016/j.molp.2014.11.008. Epub 2014 Dec 11.

title: Crystallographic investigations of select cathinones: emerging illicit street drugs known as `bath salts'.
authors: ['Wood MR', 'Lalancette RA', 'Bernal I']
source: Acta Crystallogr C Struct Chem. 2015 Jan;71(Pt 1):32-8. doi: 10.1107/S2053229614025637. Epub 2015 Jan 1.

title: A genome to unveil the mysteries of orchids.
authors: ['Albert VA', 'Carretero-Paulet L']
source: Nat Genet. 2015 Jan;47(1):3-4. doi: 10.1038/ng.3179.

title: Temporal patterns of orchid mycorrhizal fungi in meadows and forests as revealed by 454 pyrosequencing.
authors: ['Oja J', 'Kohout P', 'Tedersoo L', 'Kull T', 'Koljalg U']
source: New Phytol. 2015 Mar;205(4):1608-18. doi: 10.1111/nph.13223. Epub 2014 Dec 24.

title: Interests shape how adolescents pay attention: the interaction of motivation and top-down attentional processes in biasing sensory activations to anticipated events.
authors: ['Banerjee S', 'Frey HP', 'Molholm S', 'Foxe JJ']
source: Eur J Neurosci. 2015 Mar;41(6):818-34. doi: 10.1111/ejn.12810. Epub 2014 Dec 26.

title: Are carbon and nitrogen exchange between fungi and the orchid Goodyera repens affected by irradiance?
authors: ['Liebel HT', 'Bidartondo MI', 'Gebauer G']
source: Ann Bot. 2015 Feb;115(2):251-61. doi: 10.1093/aob/mcu240. Epub 2014 Dec 22.

title: Taxonomic notes and distribution extension of Durga Das's leaf-nosed bat Hipposiderosdurgadasi Khajuria, 1970 (Chiroptera: Hipposideridae) from south India.
authors: ['Kaur H', 'Chelmala S', 'Srinivasulu B', 'Shah TA', 'Devender G', 'Srinivasulu A']
source: Biodivers Data J. 2014 Nov 20;(2):e4127. doi: 10.3897/BDJ.2.e4127. eCollection 2014.

title: Characterization and expression analysis of somatic embryogenesis receptor-like kinase genes from Phalaenopsis.
authors: ['Huang YW', 'Tsai YJ', 'Chen FC']
source: Genet Mol Res. 2014 Dec 18;13(4):10690-703. doi: 10.4238/2014.December.18.11.

title: [Effects of different fungi on symbiotic seed germination of two Dendrobium species].
authors: ['Zi XM', 'Gao JY']
source: Zhongguo Zhong Yao Za Zhi. 2014 Sep;39(17):3238-44.

title: Conditioned Medium Reconditions Hippocampal Neurons against Kainic Acid Induced Excitotoxicity: An In Vitro Study.
authors: ['Bevinahal PK', 'Venugopal C', 'Yencharla HC', 'Chandanala S', 'Trichur RR', 'Talakad SN', 'Bhonde RR', 'Dhanushkodi A']
source: J Toxicol. 2014;2014:194967. doi: 10.1155/2014/194967. Epub 2014 Nov 23.

title: Histone acetylation accompanied with promoter sequences displaying differential expression profiles of B-class MADS-box genes for phalaenopsis floral morphogenesis.
authors: ['Hsu CC', 'Wu PS', 'Chen TC', 'Yu CW', 'Tsai WC', 'Wu K', 'Wu WL', 'Chen WH', 'Chen HH']
source: PLoS One. 2014 Dec 11;9(12):e106033. doi: 10.1371/journal.pone.0106033. eCollection 2014.

title: The treatment of displaced intra-articular distal radius fractures in elderly patients.
authors: ['Bartl C', 'Stengel D', 'Bruckner T', 'Gebhard F']
source: Dtsch Arztebl Int. 2014 Nov 14;111(46):779-87. doi: 10.3238/arztebl.2014.0779.

title: "Double-trick" visual and chemical mimicry by the juvenile orchid mantis hymenopus coronatus used in predation of the oriental honeybee apis cerana.
authors: ['Mizuno T', 'Yamaguchi S', 'Yamamoto I', 'Yamaoka R', 'Akino T']
source: Zoolog Sci. 2014 Dec;31(12):795-801. doi: 10.2108/zs140126.

title: Role of auxin in orchid development.
authors: ['Novak SD', 'Luna LJ', 'Gamage RN']
source: Plant Signal Behav. 2014;9(10):e972277. doi: 10.4161/psb.32169.

title: Orchid mating: the anther steps onto the stigma.
authors: ['Chen LJ', 'Liu ZJ']
source: Plant Signal Behav. 2014;9(11):e976484. doi: 10.4161/15592324.2014.976484.

title: Plant and fungal gene expression in mycorrhizal protocorms of the orchid Serapias vomeracea colonized by Tulasnella calospora.
authors: ['Balestrini R', 'Nerva L', 'Sillo F', 'Girlanda M', 'Perotto S']
source: Plant Signal Behav. 2014;9(11):e977707. doi: 10.4161/15592324.2014.977707.

title: Development of Cymbidium ensifolium genic-SSR markers and their utility in genetic diversity and population structure analysis in cymbidiums.
authors: ['Li X', 'Jin F', 'Jin L', 'Jackson A', 'Huang C', 'Li K', 'Shu X']
source: BMC Genet. 2014 Dec 5;15:124. doi: 10.1186/s12863-014-0124-5.

title: Antinociceptive and cytotoxic activities of an epiphytic medicinal orchid: Vanda tessellata Roxb.
authors: ['Chowdhury MA', 'Rahman MM', 'Chowdhury MR', 'Uddin MJ', 'Sayeed MA', 'Hossain MA']
source: BMC Complement Altern Med. 2014 Dec 3;14:464. doi: 10.1186/1472-6882-14-464.

title: Climate change: bees and orchids lose touch.
authors: ['Willmer P']
source: Curr Biol. 2014 Dec 1;24(23):R1133-5. doi: 10.1016/j.cub.2014.10.061. Epub 2014 Dec 1.

title: Mudskipper genomes provide insights into the terrestrial adaptation of amphibious fishes.
authors: ['You X', 'Bian C', 'Zan Q', 'Xu X', 'Liu X', 'Chen J', 'Wang J', 'Qiu Y', 'Li W', 'Zhang X', 'Sun Y', 'Chen S', 'Hong W', 'Li Y', 'Cheng S', 'Fan G', 'Shi C', 'Liang J', 'Tom Tang Y', 'Yang C', 'Ruan Z', 'Bai J', 'Peng C', 'Mu Q', 'Lu J', 'Fan M', 'Yang S', 'Huang Z', 'Jiang X', 'Fang X', 'Zhang G', 'Zhang Y', 'Polgar G', 'Yu H', 'Li J', 'Liu Z', 'Zhang G', 'Ravi V', 'Coon SL', 'Wang J', 'Yang H', 'Venkatesh B', 'Wang J', 'Shi Q']
source: Nat Commun. 2014 Dec 2;5:5594. doi: 10.1038/ncomms6594.

title: Traditional uses of medicinal plants in gastrointestinal disorders in Nepal.
authors: ['Rokaya MB', 'Uprety Y', 'Poudel RC', 'Timsina B', 'Munzbergova Z', 'Asselin H', 'Tiwari A', 'Shrestha SS', 'Sigdel SR']
source: J Ethnopharmacol. 2014 Dec 2;158 Pt A:221-9. doi: 10.1016/j.jep.2014.10.014. Epub 2014 Oct 18.

title: Potential disruption of pollination in a sexually deceptive orchid by climatic change.
authors: ['Robbirt KM', 'Roberts DL', 'Hutchings MJ', 'Davy AJ']
source: Curr Biol. 2014 Dec 1;24(23):2845-9. doi: 10.1016/j.cub.2014.10.033. Epub 2014 Nov 6.

title: CLL2-1, a chemical derivative of orchid 1,4-phenanthrenequinones, inhibits human platelet aggregation through thiol modification of calcium-diacylglycerol guanine nucleotide exchange factor-I (CalDAG-GEFI).
authors: ['Liao CY', 'Lee CL', 'Wang HC', 'Liang SS', 'Kung PH', 'Wu YC', 'Chang FR', 'Wu CC']
source: Free Radic Biol Med. 2015 Jan;78:101-10. doi: 10.1016/j.freeradbiomed.2014.10.512. Epub 2014 Oct 29.

title: Individualizing hospital care for children and young people with learning disabilities: it's the little things that make the difference.
authors: ['Oulton K', 'Sell D', 'Kerry S', 'Gibson F']
source: J Pediatr Nurs. 2015 Jan-Feb;30(1):78-86. doi: 10.1016/j.pedn.2014.10.006. Epub 2014 Oct 23.

title: Ethanolic extract of Coelogyne cristata Lindley (Orchidaceae) and its compound coelogin promote osteoprotective activity in ovariectomized estrogen deficient mice.
authors: ['Sharma C', 'Mansoori MN', 'Dixit M', 'Shukla P', 'Kumari T', 'Bhandari SP', 'Narender T', 'Singh D', 'Arya KR']
source: Phytomedicine. 2014 Oct 15;21(12):1702-7. doi: 10.1016/j.phymed.2014.08.008. Epub 2014 Sep 16.

title: Virus resistance in orchids.
authors: ['Koh KW', 'Lu HC', 'Chan MT']
source: Plant Sci. 2014 Nov;228:26-38. doi: 10.1016/j.plantsci.2014.04.015. Epub 2014 Apr 28.

title: In vitro regeneration and ploidy level analysis of Eulophia ochreata Lindl.
authors: ['Shriram V', 'Nanekar V', 'Kumar V', 'Kavi Kishor PB']
source: Indian J Exp Biol. 2014 Nov;52(11):1112-21.

title: A novel animal model of metabolic syndrome with non-alcoholic fatty liver disease and skin inflammation.
authors: ['Kulkarni NM', 'Jaji MS', 'Shetty P', 'Kurhe YV', 'Chaudhary S', 'Vijaykant G', 'Raghul J', 'Vishwakarma SL', 'Rajesh BN', 'Mookkan J', 'Krishnan UM', 'Narayanan S']
source: Pharm Biol. 2015 Aug;53(8):1110-7. doi: 10.3109/13880209.2014.960944. Epub 2014 Nov 28.

title: Identification and Molecular Characterization of Nuclear Citrus leprosis virus, a Member of the Proposed Dichorhavirus Genus Infecting Multiple Citrus Species in Mexico.
authors: ['Roy A', 'Stone AL', 'Shao J', 'Otero-Colina G', 'Wei G', 'Choudhary N', 'Achor D', 'Levy L', 'Nakhla MK', 'Hartung JS', 'Schneider WL', 'Brlansky RH']
source: Phytopathology. 2015 Apr;105(4):564-75. doi: 10.1094/PHYTO-09-14-0245-R.

title: Raising the sugar content--orchid bees overcome the constraints of suction feeding through manipulation of nectar and pollen provisions.
authors: ['Pokorny T', 'Lunau K', 'Eltz T']
source: PLoS One. 2014 Nov 25;9(11):e113823. doi: 10.1371/journal.pone.0113823. eCollection 2014.

title: Using ecological niche models and niche analyses to understand speciation patterns: the case of sister neotropical orchid bees.
authors: ['Silva DP', 'Vilela B', 'De Marco P Jr', 'Nemesio A']
source: PLoS One. 2014 Nov 25;9(11):e113246. doi: 10.1371/journal.pone.0113246. eCollection 2014.

title: Rapid cytolysis of Mycobacterium tuberculosis by faropenem, an orally bioavailable beta-lactam antibiotic.
authors: ['Dhar N', 'Dubee V', 'Ballell L', 'Cuinet G', 'Hugonnet JE', 'Signorino-Gelo F', 'Barros D', 'Arthur M', 'McKinney JD']
source: Antimicrob Agents Chemother. 2015 Feb;59(2):1308-19. doi: 10.1128/AAC.03461-14. Epub 2014 Nov 24.

title: The genome sequence of the orchid Phalaenopsis equestris.
authors: ['Cai J', 'Liu X', 'Vanneste K', 'Proost S', 'Tsai WC', 'Liu KW', 'Chen LJ', 'He Y', 'Xu Q', 'Bian C', 'Zheng Z', 'Sun F', 'Liu W', 'Hsiao YY', 'Pan ZJ', 'Hsu CC', 'Yang YP', 'Hsu YC', 'Chuang YC', 'Dievart A', 'Dufayard JF', 'Xu X', 'Wang JY', 'Wang J', 'Xiao XJ', 'Zhao XM', 'Du R', 'Zhang GQ', 'Wang M', 'Su YY', 'Xie GC', 'Liu GH', 'Li LQ', 'Huang LQ', 'Luo YB', 'Chen HH', 'Van de Peer Y', 'Liu ZJ']
source: Nat Genet. 2015 Jan;47(1):65-72. doi: 10.1038/ng.3149. Epub 2014 Nov 24.

title: Establishment of an efficient in vitro regeneration protocol for rapid and mass propagation of Dendrobium chrysotoxum Lindl. using seed culture.
authors: ['Nongdam P', 'Tikendra L']
source: ScientificWorldJournal. 2014;2014:740150. doi: 10.1155/2014/740150. Epub 2014 Oct 20.

title: Characterization of arbuscular mycorrhizal fungus communities of Aquilaria crassna and Tectona grandis roots and soils in Thailand plantations.
authors: ['Chaiyasen A', 'Young JP', 'Teaumroong N', 'Gavinlertvatana P', 'Lumyong S']
source: PLoS One. 2014 Nov 14;9(11):e112591. doi: 10.1371/journal.pone.0112591. eCollection 2014.

title: Floral isolation is the major reproductive barrier between a pair of rewarding orchid sister species.
authors: ['Sun M', 'Schluter PM', 'Gross K', 'Schiestl FP']
source: J Evol Biol. 2015 Jan;28(1):117-29. doi: 10.1111/jeb.12544. Epub 2015 Jan 5.

title: Temporal variation in mycorrhizal diversity and carbon and nitrogen stable isotope abundance in the wintergreen meadow orchid Anacamptis morio.
authors: ['Ercole E', 'Adamo M', 'Rodda M', 'Gebauer G', 'Girlanda M', 'Perotto S']
source: New Phytol. 2015 Feb;205(3):1308-19. doi: 10.1111/nph.13109. Epub 2014 Nov 10.

title: A deep transcriptomic analysis of pod development in the vanilla orchid (Vanilla planifolia).
authors: ['Rao X', 'Krom N', 'Tang Y', 'Widiez T', 'Havkin-Frenkel D', 'Belanger FC', 'Dixon RA', 'Chen F']
source: BMC Genomics. 2014 Nov 7;15:964. doi: 10.1186/1471-2164-15-964.

title: The life of phi: the development of phi thickenings in roots of the orchids of the genus Miltoniopsis.
authors: ['Idris NA', 'Collings DA']
source: Planta. 2015 Feb;241(2):489-506. doi: 10.1007/s00425-014-2194-z. Epub 2014 Nov 7.

title: Genic rather than genome-wide differences between sexually deceptive Ophrys orchids with different pollinators.
authors: ['Sedeek KE', 'Scopece G', 'Staedler YM', 'Schonenberger J', 'Cozzolino S', 'Schiestl FP', 'Schluter PM']
source: Mol Ecol. 2014 Dec;23(24):6192-205. doi: 10.1111/mec.12992. Epub 2014 Nov 27.

title: Comparative proteomic analysis of labellum and inner lateral petals in Cymbidium ensifolium flowers.
authors: ['Li X', 'Xu W', 'Chowdhury MR', 'Jin F']
source: Int J Mol Sci. 2014 Oct 31;15(11):19877-97. doi: 10.3390/ijms151119877.

title: In vitro propagation and reintroduction of the endangered Renanthera imschootiana Rolfe.
authors: ['Wu K', 'Zeng S', 'Lin D', 'Teixeira da Silva JA', 'Bu Z', 'Zhang J', 'Duan J']
source: PLoS One. 2014 Oct 28;9(10):e110033. doi: 10.1371/journal.pone.0110033. eCollection 2014.

title: The velamen protects photosynthetic orchid roots against UV-B damage, and a large dated phylogeny implies multiple gains and losses of this function during the Cenozoic.
authors: ['Chomicki G', 'Bidel LP', 'Ming F', 'Coiro M', 'Zhang X', 'Wang Y', 'Baissac Y', 'Jay-Allemand C', 'Renner SS']
source: New Phytol. 2015 Feb;205(3):1330-41. doi: 10.1111/nph.13106. Epub 2014 Oct 23.

title: Prolonged exposure to elevated temperature induces floral transition via up-regulation of cytosolic ascorbate peroxidase 1 and subsequent reduction of the ascorbate redox ratio in Oncidium hybrid orchid.
authors: ['Chin DC', 'Shen CH', 'SenthilKumar R', 'Yeh KW']
source: Plant Cell Physiol. 2014 Dec;55(12):2164-76. doi: 10.1093/pcp/pcu146. Epub 2014 Oct 14.

title: Mycorrhizal fungal diversity and community composition in a lithophytic and epiphytic orchid.
authors: ['Xing X', 'Gai X', 'Liu Q', 'Hart MM', 'Guo S']
source: Mycorrhiza. 2015 May;25(4):289-96. doi: 10.1007/s00572-014-0612-5. Epub 2014 Oct 17.

title: Topical atorvastatin ameliorates 12-O-tetradecanoylphorbol-13-acetate induced skin inflammation by reducing cutaneous cytokine levels and NF-kappaB activation.
authors: ['Kulkarni NM', 'Muley MM', 'Jaji MS', 'Vijaykanth G', 'Raghul J', 'Reddy NK', 'Vishwakarma SL', 'Rajesh NB', 'Mookkan J', 'Krishnan UM', 'Narayanan S']
source: Arch Pharm Res. 2015 Jun;38(6):1238-47. doi: 10.1007/s12272-014-0496-0. Epub 2014 Oct 14.

title: Crystal structure of 3-methyl-2,6-bis-(4-methyl-1,3-thia-zol-5-yl)piperidin-4-one.
authors: ['Manimaran A', 'Sethusankar K', 'Ganesan S', 'Ananthan S']
source: Acta Crystallogr Sect E Struct Rep Online. 2014 Aug 30;70(Pt 9):o1055. doi: 10.1107/S1600536814018856. eCollection 2014 Sep 1.

title: Molecular phylogeny and evolutionary history of the Eurasiatic orchid genus Himantoglossum s.l. (Orchidaceae).
authors: ['Sramko G', 'Attila MV', 'Hawkins JA', 'Bateman RM']
source: Ann Bot. 2014 Dec;114(8):1609-26. doi: 10.1093/aob/mcu179. Epub 2014 Oct 7.

title: A flavonoid isolated from Streptomyces sp. (ERINLG-4) induces apoptosis in human lung cancer A549 cells through p53 and cytochrome c release caspase dependant pathway.
authors: ['Balachandran C', 'Sangeetha B', 'Duraipandiyan V', 'Raj MK', 'Ignacimuthu S', 'Al-Dhabi NA', 'Balakrishna K', 'Parthasarathy K', 'Arulmozhi NM', 'Arasu MV']
source: Chem Biol Interact. 2014 Dec 5;224:24-35. doi: 10.1016/j.cbi.2014.09.019. Epub 2014 Oct 5.

title: The folklore medicinal orchids of Sikkim.
authors: ['Panda AK', 'Mandal D']
source: Anc Sci Life. 2013 Oct;33(2):92-6. doi: 10.4103/0257-7941.139043.

title: Effect of cryopreservation on in vitro seed germination and protocorm growth of Mediterranean orchids.
authors: ['Pirondini A', 'Sgarbi E']
source: Cryo Letters. 2014 Jul-Aug;35(4):327-35.

title: Do chlorophyllous orchids heterotrophically use mycorrhizal fungal carbon?
authors: ['Selosse MA', 'Martos F']
source: Trends Plant Sci. 2014 Nov;19(11):683-5.

title: Vanillin - Bioconversion and Bioengineering of the most popular plant flavour and its de novo biosynthesis in the vanilla orchid.
authors: ['Gallage NJ', 'Moeller BL']
source: Mol Plant. 2014 Sep 30. pii: ssu105.

title: Authenticity and traceability of vanilla flavors by analysis of stable isotopes of carbon and hydrogen.
authors: ['Hansen AM', 'Fromberg A', 'Frandsen HL']
source: J Agric Food Chem. 2014 Oct 22;62(42):10326-31. doi: 10.1021/jf503055k. Epub 2014 Oct 13.

title: Are winter-active species vulnerable to climate warming? A case study with the wintergreen terrestrial orchid, Tipularia discolor.
authors: ['Marchin RM', 'Dunn RR', 'Hoffmann WA']
source: Oecologia. 2014 Dec;176(4):1161-72. doi: 10.1007/s00442-014-3074-8. Epub 2014 Sep 26.

title: Antimicrobial compounds from leaf extracts of Jatropha curcas, Psidium guajava, and Andrographis paniculata.
authors: ['Rahman MM', 'Ahmad SH', 'Mohamed MT', 'Ab Rahman MZ']
source: ScientificWorldJournal. 2014;2014:635240. doi: 10.1155/2014/635240. Epub 2014 Aug 26.

title: Eugenol synthase genes in floral scent variation in Gymnadenia species.
authors: ['Gupta AK', 'Schauvinhold I', 'Pichersky E', 'Schiestl FP']
source: Funct Integr Genomics. 2014 Dec;14(4):779-88. doi: 10.1007/s10142-014-0397-9. Epub 2014 Sep 20.

title: Bavituximab plus paclitaxel and carboplatin for the treatment of advanced non-small-cell lung cancer.
authors: ['Digumarti R', 'Bapsy PP', 'Suresh AV', 'Bhattacharyya GS', 'Dasappa L', 'Shan JS', 'Gerber DE']
source: Lung Cancer. 2014 Nov;86(2):231-6. doi: 10.1016/j.lungcan.2014.08.010. Epub 2014 Aug 24.

title: Isolation and differential expression of a novel MAP kinase gene DoMPK4 in Dendrobium officinale.
authors: ['Zhang G', 'Li YM', 'Hu BX', 'Zhang DW', 'Guo SX']
source: Yao Xue Xue Bao. 2014 Jul;49(7):1076-83.

title: RNA interference-based gene silencing of phytoene synthase impairs growth, carotenoids, and plastid phenotype in Oncidium hybrid orchid.
authors: ['Liu JX', 'Chiou CY', 'Shen CH', 'Chen PJ', 'Liu YC', 'Jian CD', 'Shen XL', 'Shen FQ', 'Yeh KW']
source: Springerplus. 2014 Aug 28;3:478. doi: 10.1186/2193-1801-3-478. eCollection 2014.

title: Development of phylogenetic markers for Sebacina (Sebacinaceae) mycorrhizal fungi associated with Australian orchids.
authors: ['Ruibal MP', 'Peakall R', 'Foret S', 'Linde CC']
source: Appl Plant Sci. 2014 Jun 4;2(6). pii: apps.1400015. doi: 10.3732/apps.1400015. eCollection 2014 Jun.

title: Characterization of 13 microsatellite markers for Diuris basaltica (Orchidaceae) and related species.
authors: ['Ahrens CW', 'James EA']
source: Appl Plant Sci. 2014 Jan 7;2(1). pii: apps.1300069. doi: 10.3732/apps.1300069. eCollection 2014 Jan.

title: Pregnancy influences the plasma pharmacokinetics but not the cerebrospinal fluid pharmacokinetics of raltegravir: a preclinical investigation.
authors: ['Mahat MY', 'Thippeswamy BS', 'Khan FR', 'Edunuri R', 'Nidhyanandan S', 'Chaudhary S']
source: Eur J Pharm Sci. 2014 Dec 18;65:38-44. doi: 10.1016/j.ejps.2014.08.012. Epub 2014 Sep 6.

title: Temporal and spatial regulation of anthocyanin biosynthesis provide diverse flower colour intensities and patterning in Cymbidium orchid.
authors: ['Wang L', 'Albert NW', 'Zhang H', 'Arathoon S', 'Boase MR', 'Ngo H', 'Schwinn KE', 'Davies KM', 'Lewis DH']
source: Planta. 2014 Nov;240(5):983-1002. doi: 10.1007/s00425-014-2152-9. Epub 2014 Sep 3.

title: Deep sequencing-based comparative transcriptional profiles of Cymbidium hybridum roots in response to mycorrhizal and non-mycorrhizal beneficial fungi.
authors: ['Zhao X', 'Zhang J', 'Chen C', 'Yang J', 'Zhu H', 'Liu M', 'Lv F']
source: BMC Genomics. 2014 Aug 31;15:747. doi: 10.1186/1471-2164-15-747.

title: A microfluidic system integrated with buried optical fibers for detection of Phalaenopsis orchid pathogens.
authors: ['Lin CL', 'Chang WH', 'Wang CH', 'Lee CH', 'Chen TY', 'Jan FJ', 'Lee GB']
source: Biosens Bioelectron. 2015 Jan 15;63:572-9. doi: 10.1016/j.bios.2014.08.013. Epub 2014 Aug 17.

title: Role of Auxin in orchid development.
authors: ['Darling-Novak S', 'Luna LJ', 'Gamage RN']
source: Plant Signal Behav. 2014 Aug 25;9. pii: e32169.

title: Predicting progression of Alzheimer's disease using ordinal regression.
authors: ['Doyle OM', 'Westman E', 'Marquand AF', 'Mecocci P', 'Vellas B', 'Tsolaki M', 'Kloszewska I', 'Soininen H', 'Lovestone S', 'Williams SC', 'Simmons A']
source: PLoS One. 2014 Aug 20;9(8):e105542. doi: 10.1371/journal.pone.0105542. eCollection 2014.

title: Identity and specificity of Rhizoctonia-like fungi from different populations of Liparis japonica (Orchidaceae) in Northeast China.
authors: ['Ding R', 'Chen XH', 'Zhang LJ', 'Yu XD', 'Qu B', 'Duan R', 'Xu YF']
source: PLoS One. 2014 Aug 20;9(8):e105573. doi: 10.1371/journal.pone.0105573. eCollection 2014.

title: Labellar anatomy and secretion in Bulbophyllum Thouars (Orchidaceae: Bulbophyllinae) sect. Racemosae Benth. & Hook. f.
authors: ['Davies KL', 'Stpiczynska M']
source: Ann Bot. 2014 Oct;114(5):889-911. doi: 10.1093/aob/mcu153. Epub 2014 Aug 13.

title: Molecular characterization and functional analysis of a Flowering locus T homolog gene from a Phalaenopsis orchid.
authors: ['Li DM', 'L FB', 'Zhu GF', 'Sun YB', 'Liu HL', 'Liu JW', 'Wang Z']
source: Genet Mol Res. 2014 Aug 7;13(3):5982-94. doi: 10.4238/2014.August.7.14.

title: Composition and conservation of Orchidaceae on an inselberg in the Brazilian Atlantic Forest and floristic relationships with areas of Eastern Brazil.
authors: ['Pessanha AS', 'Menini Neto L', 'Forzza RC', 'Nascimento MT']
source: Rev Biol Trop. 2014 Jun;62(2):829-41.

title: The complete chloroplast genome of Phalaenopsis "Tiny Star".
authors: ['Kim GB', 'Kwon Y', 'Yu HJ', 'Lim KB', 'Seo JH', 'Mun JH']
source: Mitochondrial DNA. 2016 Mar;27(2):1300-2. doi: 10.3109/19401736.2014.945566. Epub 2014 Aug 5.

title: The cultural and ecological impacts of aboriginal tourism: a case study on Taiwan's Tao tribe.
authors: ['Liu TM', 'Lu DJ']
source: Springerplus. 2014 Jul 8;3:347. doi: 10.1186/2193-1801-3-347. eCollection 2014.

title: Verifying likelihoods for low template DNA profiles using multiple replicates.
authors: ['Steele CD', 'Greenhalgh M', 'Balding DJ']
source: Forensic Sci Int Genet. 2014 Nov;13:82-9. doi: 10.1016/j.fsigen.2014.06.018. Epub 2014 Jul 10.

title: Development of microsatellite markers of vandaceous orchids for species and variety identification.
authors: ['Peyachoknagul S', 'Nettuwakul C', 'Phuekvilai P', 'Wannapinpong S', 'Srikulnath K']
source: Genet Mol Res. 2014 Jul 24;13(3):5441-5. doi: 10.4238/2014.July.24.23.

title: Bayesian estimates of transition probabilities in seven small lithophytic orchid populations: maximizing data availability from many small samples.
authors: ['Tremblay RL', 'McCarthy MA']
source: PLoS One. 2014 Jul 28;9(7):e102859. doi: 10.1371/journal.pone.0102859. eCollection 2014.

title: Occurrence of Bacillus amyloliquefaciens as a systemic endophyte of vanilla orchids.
authors: ['White JF Jr', 'Torres MS', 'Sullivan RF', 'Jabbour RE', 'Chen Q', 'Tadych M', 'Irizarry I', 'Bergen MS', 'Havkin-Frenkel D', 'Belanger FC']
source: Microsc Res Tech. 2014 Nov;77(11):874-85. doi: 10.1002/jemt.22410. Epub 2014 Jul 25.

title: The orchid-bee faunas (Hymenoptera: Apidae) of "Reserva Ecologica Michelin", "RPPN Serra Bonita" and one Atlantic Forest remnant in the state of Bahia, Brazil, with new geographic records.
authors: ['Nemesio A']
source: Braz J Biol. 2014 Feb;74(1):16-22.

title: The corbiculate bees arose from New World oil-collecting bees: implications for the origin of pollen baskets.
authors: ['Martins AC', 'Melo GA', 'Renner SS']
source: Mol Phylogenet Evol. 2014 Nov;80:88-94. doi: 10.1016/j.ympev.2014.07.003. Epub 2014 Jul 15.

title: Evaluation of the predacious mite Hemicheyletia wellsina (Acari: Cheyletidae) as a predator of arthropod pests of orchids.
authors: ['Ray HA', 'Hoy MA']
source: Exp Appl Acarol. 2014 Nov;64(3):287-98. doi: 10.1007/s10493-014-9833-8. Epub 2014 Jul 18.

title: De novo transcriptome assembly from inflorescence of Orchis italica: analysis of coding and non-coding transcripts.
authors: ['De Paolo S', 'Salvemini M', 'Gaudio L', 'Aceto S']
source: PLoS One. 2014 Jul 15;9(7):e102155. doi: 10.1371/journal.pone.0102155. eCollection 2014.

title: Desiccation tolerance, longevity and seed-siring ability of entomophilous pollen from UK native orchid species.
authors: ['Marks TR', 'Seaton PT', 'Pritchard HW']
source: Ann Bot. 2014 Sep;114(3):561-9. doi: 10.1093/aob/mcu139. Epub 2014 Jul 8.

title: High levels of effective long-distance dispersal may blur ecotypic divergence in a rare terrestrial orchid.
authors: ['Vanden Broeck A', 'Van Landuyt W', 'Cox K', 'De Bruyn L', 'Gyselings R', 'Oostermeijer G', 'Valentin B', 'Bozic G', 'Dolinar B', 'Illyes Z', 'Mergeay J']
source: BMC Ecol. 2014 Jul 7;14:20. doi: 10.1186/1472-6785-14-20.

title: Conservation genetics of an endangered lady's slipper orchid: Cypripedium japonicum in China.
authors: ['Qian X', 'Li QJ', 'Liu F', 'Gong MJ', 'Wang CX', 'Tian M']
source: Int J Mol Sci. 2014 Jun 30;15(7):11578-96. doi: 10.3390/ijms150711578.

title: Multiplex RT-PCR detection of three common viruses infecting orchids.
authors: ['Ali RN', 'Dann AL', 'Cross PA', 'Wilson CR']
source: Arch Virol. 2014 Nov;159(11):3095-9. doi: 10.1007/s00705-014-2161-9. Epub 2014 Jul 1.

title: Agrobacterium-mediated transformation of the recalcitrant Vanda Kasem's Delight orchid with higher efficiency.
authors: ['Gnasekaran P', 'Antony JJ', 'Uddain J', 'Subramaniam S']
source: ScientificWorldJournal. 2014;2014:583934. doi: 10.1155/2014/583934. Epub 2014 Apr 8.

title: Cold response in Phalaenopsis aphrodite and characterization of PaCBF1 and PaICE1.
authors: ['Peng PH', 'Lin CH', 'Tsai HW', 'Lin TY']
source: Plant Cell Physiol. 2014 Sep;55(9):1623-35. doi: 10.1093/pcp/pcu093. Epub 2014 Jun 27.

title: Volatile fingerprint of italian populations of orchids using solid phase microextraction and gas chromatography coupled with mass spectrometry.
authors: ['Manzo A', 'Panseri S', 'Vagge I', 'Giorgi A']
source: Molecules. 2014 Jun 11;19(6):7913-36. doi: 10.3390/molecules19067913.

title: [Molecular characterization of a HMG-CoA reductase gene from a rare and endangered medicinal plant, Dendrobium officinale].
authors: ['Zhang L', 'Wang JT', 'Zhang DW', 'Zhang G', 'Guo SX']
source: Yao Xue Xue Bao. 2014 Mar;49(3):411-8.

title: Antitumor activity of ethanolic extract of Dendrobium formosum in T-cell lymphoma: an in vitro and in vivo study.
authors: ['Prasad R', 'Koch B']
source: Biomed Res Int. 2014;2014:753451. doi: 10.1155/2014/753451. Epub 2014 May 18.

title: New insight into the regulation of floral morphogenesis.
authors: ['Tsai WC', 'Pan ZJ', 'Su YY', 'Liu ZJ']
source: Int Rev Cell Mol Biol. 2014;311:157-82. doi: 10.1016/B978-0-12-800179-0.00003-9.

title: Effects of pollination limitation and seed predation on female reproductive success of a deceptive orchid.
authors: ['Walsh RP', 'Arnold PM', 'Michaels HJ']
source: AoB Plants. 2014 Jun 9;6. pii: plu031. doi: 10.1093/aobpla/plu031.

title: Multiple isoforms of phosphoenolpyruvate carboxylase in the Orchidaceae (subtribe Oncidiinae): implications for the evolution of crassulacean acid metabolism.
authors: ['Silvera K', 'Winter K', 'Rodriguez BL', 'Albion RL', 'Cushman JC']
source: J Exp Bot. 2014 Jul;65(13):3623-36. doi: 10.1093/jxb/eru234. Epub 2014 Jun 9.

title: Comparative chloroplast genomes of photosynthetic orchids: insights into evolution of the Orchidaceae and development of molecular markers for phylogenetic applications.
authors: ['Luo J', 'Hou BW', 'Niu ZT', 'Liu W', 'Xue QY', 'Ding XY']
source: PLoS One. 2014 Jun 9;9(6):e99016. doi: 10.1371/journal.pone.0099016. eCollection 2014.

title: Speciation via floral heterochrony and presumed mycorrhizal host switching of endemic butterfly orchids on the Azorean archipelago.
authors: ['Bateman RM', 'Rudall PJ', 'Bidartondo MI', 'Cozzolino S', 'Tranchida-Lombardo V', 'Carine MA', 'Moura M']
source: Am J Bot. 2014 Jun 6;101(6):979-1001.

title: Pollen competition between two sympatric Orchis species (Orchidaceae): the overtaking of conspecific of heterospecific pollen as a reproductive barrier.
authors: ['Luca A', 'Palermo AM', 'Bellusci F', 'Pellegrino G']
source: Plant Biol (Stuttg). 2015 Jan;17(1):219-25. doi: 10.1111/plb.12199. Epub 2014 May 30.

title: In vitro conservation of Dendrobium germplasm.
authors: ['Teixeira da Silva JA', 'Zeng S', 'Galdiano RF Jr', 'Dobranszki J', 'Cardoso JC', 'Vendrame WA']
source: Plant Cell Rep. 2014 Sep;33(9):1413-23. doi: 10.1007/s00299-014-1631-6. Epub 2014 May 21.

title: Gigantol, a bibenzyl from Dendrobium draconis, inhibits the migratory behavior of non-small cell lung cancer cells.
authors: ['Charoenrungruang S', 'Chanvorachote P', 'Sritularak B', 'Pongrakhananon V']
source: J Nat Prod. 2014 Jun 27;77(6):1359-66. doi: 10.1021/np500015v. Epub 2014 May 20.

title: The analysis of the inflorescence miRNome of the orchid Orchis italica reveals a DEF-like MADS-box gene as a new miRNA target.
authors: ['Aceto S', 'Sica M', 'De Paolo S', "D'Argenio V", 'Cantiello P', 'Salvatore F', 'Gaudio L']
source: PLoS One. 2014 May 15;9(5):e97839. doi: 10.1371/journal.pone.0097839. eCollection 2014.

title: Factors affecting the distribution pattern of wild plants with extremely small populations in Hainan Island, China.
authors: ['Chen Y', 'Yang X', 'Yang Q', 'Li D', 'Long W', 'Luo W']
source: PLoS One. 2014 May 15;9(5):e97751. doi: 10.1371/journal.pone.0097751. eCollection 2014.

title: [Temporal and spatial variations of soil NO(3-)-N in Orychophragmus violaceus/spring maize rotation system in North China].
authors: ['Xiong J', 'Wang GL', 'Cao WD', 'Bai JS', 'Zeng NH', 'Yang L', 'Gao SJ', 'Shimizu K']
source: Ying Yong Sheng Tai Xue Bao. 2014 Feb;25(2):467-73.

title: Chemical composition, potential toxicity, and quality control procedures of the crude drug of Cyrtopodium macrobulbon.
authors: ['Morales-Sanchez V', 'Rivero-Cruz I', 'Laguna-Hernandez G', 'Salazar-Chavez G', 'Mata R']
source: J Ethnopharmacol. 2014 Jul 3;154(3):790-7. doi: 10.1016/j.jep.2014.05.006. Epub 2014 May 10.

title: Nutritional regulation in mixotrophic plants: new insights from Limodorum abortivum.
authors: ['Bellino A', 'Alfani A', 'Selosse MA', 'Guerrieri R', 'Borghetti M', 'Baldantoni D']
source: Oecologia. 2014 Jul;175(3):875-85. doi: 10.1007/s00442-014-2940-8. Epub 2014 May 11.

title: Evaluation of internal control for gene expression in Phalaenopsis by quantitative real-time PCR.
authors: ['Yuan XY', 'Jiang SH', 'Wang MF', 'Ma J', 'Zhang XY', 'Cui B']
source: Appl Biochem Biotechnol. 2014 Jul;173(6):1431-45. doi: 10.1007/s12010-014-0951-x. Epub 2014 May 9.

title: Male interference with pollination efficiency in a hermaphroditic orchid.
authors: ['Duffy KJ', 'Johnson SD']
source: J Evol Biol. 2014 Aug;27(8):1751-6. doi: 10.1111/jeb.12395. Epub 2014 May 6.

title: Biodegradation of polystyrene-graft-starch copolymers in three different types of soil.
authors: ['Nikolic V', 'Velickovic S', 'Popovic A']
source: Environ Sci Pollut Res Int. 2014;21(16):9877-86. doi: 10.1007/s11356-014-2946-0. Epub 2014 May 3.

title: Mycorrhizal compatibility and symbiotic reproduction of Gavilea australis, an endangered terrestrial orchid from south Patagonia.
authors: ['Fracchia S', 'Aranda-Rickert A', 'Flachsland E', 'Terada G', 'Sede S']
source: Mycorrhiza. 2014 Nov;24(8):627-34. doi: 10.1007/s00572-014-0579-2. Epub 2014 Apr 30.

title: Bioguided identification of antifungal and antiproliferative compounds from the Brazilian orchid Miltonia flavescens Lindl.
authors: ['Porte LF', 'Santin SM', 'Chiavelli LU', 'Silva CC', 'Faria TJ', 'Faria RT', 'Ruiz AL', 'Carvalho JE', 'Pomini AM']
source: Z Naturforsch C. 2014 Jan-Feb;69(1-2):46-52.

title: Helvolic acid, an antibacterial nortriterpenoid from a fungal endophyte, sp. of orchid endemic to Sri Lanka.
authors: ['Ratnaweera PB', 'Williams DE', 'de Silva ED', 'Wijesundera RL', 'Dalisay DS', 'Andersen RJ']
source: Mycology. 2014 Mar;5(1):23-28. Epub 2014 Mar 25.

title: Gene expression in mycorrhizal orchid protocorms suggests a friendly plant-fungus relationship.
authors: ['Perotto S', 'Rodda M', 'Benetti A', 'Sillo F', 'Ercole E', 'Rodda M', 'Girlanda M', 'Murat C', 'Balestrini R']
source: Planta. 2014 Jun;239(6):1337-49. doi: 10.1007/s00425-014-2062-x. Epub 2014 Apr 24.

title: Synthesis and mechanistic studies of a novel homoisoflavanone inhibitor of endothelial cell growth.
authors: ['Basavarajappa HD', 'Lee B', 'Fei X', 'Lim D', 'Callaghan B', 'Mund JA', 'Case J', 'Rajashekhar G', 'Seo SY', 'Corson TW']
source: PLoS One. 2014 Apr 21;9(4):e95694. doi: 10.1371/journal.pone.0095694. eCollection 2014.

title: A new phylogenetic analysis sheds new light on the relationships in the Calanthe alliance (Orchidaceae) in China.
authors: ['Zhai JW', 'Zhang GQ', 'Li L', 'Wang M', 'Chen LJ', 'Chung SW', 'Rodriguez FJ', 'Francisco-Ortega J', 'Lan SR', 'Xing FW', 'Liu ZJ']
source: Mol Phylogenet Evol. 2014 Aug;77:216-22. doi: 10.1016/j.ympev.2014.04.005. Epub 2014 Apr 18.

title: Molecular systematics of subtribe Orchidinae and Asian taxa of Habenariinae (Orchideae, Orchidaceae) based on plastid matK, rbcL and nuclear ITS.
authors: ['Jin WT', 'Jin XH', 'Schuiteman A', 'Li DZ', 'Xiang XG', 'Huang WC', 'Li JW', 'Huang LQ']
source: Mol Phylogenet Evol. 2014 Aug;77:41-53. doi: 10.1016/j.ympev.2014.04.004. Epub 2014 Apr 16.

title: Memory for expectation-violating concepts: the effects of agents and cultural familiarity.
authors: ['Porubanova M', 'Shaw DJ', 'McKay R', 'Xygalatas D']
source: PLoS One. 2014 Apr 8;9(4):e90684. doi: 10.1371/journal.pone.0090684. eCollection 2014.

title: Discovery of pyrazines as pollinator sex pheromones and orchid semiochemicals: implications for the evolution of sexual deception.
authors: ['Bohman B', 'Phillips RD', 'Menz MH', 'Berntsson BW', 'Flematti GR', 'Barrow RA', 'Dixon KW', 'Peakall R']
source: New Phytol. 2014 Aug;203(3):939-52. doi: 10.1111/nph.12800. Epub 2014 Apr 3.

title: Floral colleters in Pleurothallidinae (Epidendroideae: Orchidaceae).
authors: ['Cardoso-Gustavson P', 'Campbell LM', 'Mazzoni-Viveiros SC', 'de Barros F']
source: Am J Bot. 2014 Apr;101(4):587-97. doi: 10.3732/ajb.1400012. Epub 2014 Mar 31.

title: Expression of paralogous SEP-, FUL-, AG- and STK-like MADS-box genes in wild-type and peloric Phalaenopsis flowers.
authors: ['Acri-Nunes-Miranda R', 'Mondragon-Palomino M']
source: Front Plant Sci. 2014 Mar 12;5:76. doi: 10.3389/fpls.2014.00076. eCollection 2014.

title: Spatio-temporal Genetic Structure of a Tropical Bee Species Suggests High Dispersal Over a Fragmented Landscape.
authors: ['Suni SS', 'Bronstein JL', 'Brosi BJ']
source: Biotropica. 2014 Mar 1;46(2):202-209.

title: 2,2'-[Benzene-1,2-diylbis(iminomethanediyl)]diphenol derivative bearing two amine and hydroxyl groups as fluorescent receptor for Zinc(II) ion.
authors: ['Tayade K', 'Sahoo SK', 'Patil R', 'Singh N', 'Attarde S', 'Kuwar A']
source: Spectrochim Acta A Mol Biomol Spectrosc. 2014 May 21;126:312-6. doi: 10.1016/j.saa.2014.02.003. Epub 2014 Feb 19.

title: Climate, physiological tolerance and sex-biased dispersal shape genetic structure of Neotropical orchid bees.
authors: ['Lopez-Uribe MM', 'Zamudio KR', 'Cardoso CF', 'Danforth BN']
source: Mol Ecol. 2014 Apr;23(7):1874-90. doi: 10.1111/mec.12689. Epub 2014 Mar 18.

title: There is more to pollinator-mediated selection than pollen limitation.
authors: ['Sletvold N', 'Agren J']
source: Evolution. 2014 Jul;68(7):1907-18. doi: 10.1111/evo.12405. Epub 2014 Apr 16.

title: Three new bioactive phenolic glycosides from Liparis odorata.
authors: ['Li B', 'Liu H', 'Zhang D', 'Lai X', 'Liu B', 'Xu X', 'Xu P']
source: Nat Prod Res. 2014;28(8):522-9. doi: 10.1080/14786419.2014.880916. Epub 2014 Mar 17.

title: The evolution of floral deception in Epipactis veratrifolia (Orchidaceae): from indirect defense to pollination.
authors: ['Jin XH', 'Ren ZX', 'Xu SZ', 'Wang H', 'Li DZ', 'Li ZY']
source: BMC Plant Biol. 2014 Mar 12;14:63. doi: 10.1186/1471-2229-14-63.

title: Sexual safety practices of massage parlor-based sex workers and their clients.
authors: ['Kolar K', 'Atchison C', 'Bungay V']
source: AIDS Care. 2014;26(9):1100-4. doi: 10.1080/09540121.2014.894611. Epub 2014 Mar 12.

title: Identification of warm day and cool night conditions induced flowering-related genes in a Phalaenopsis orchid hybrid by suppression subtractive hybridization.
authors: ['Li DM', 'Lu FB', 'Zhu GF', 'Sun YB', 'Xu YC', 'Jiang MD', 'Liu JW', 'Wang Z']
source: Genet Mol Res. 2014 Feb 14;13(3):7037-51. doi: 10.4238/2014.February.14.7.

title: Transcriptional mapping of the messenger and leader RNAs of orchid fleck virus, a bisegmented negative-strand RNA virus.
authors: ['Kondo H', 'Maruyama K', 'Chiba S', 'Andika IB', 'Suzuki N']
source: Virology. 2014 Mar;452-453:166-74. doi: 10.1016/j.virol.2014.01.007. Epub 2014 Feb 4.

title: Flower development of Phalaenopsis orchid involves functionally divergent SEPALLATA-like genes.
authors: ['Pan ZJ', 'Chen YY', 'Du JS', 'Chen YY', 'Chung MC', 'Tsai WC', 'Wang CN', 'Chen HH']
source: New Phytol. 2014 May;202(3):1024-42. doi: 10.1111/nph.12723. Epub 2014 Feb 14.

title: In situ seed baiting to isolate germination-enhancing fungi for an epiphytic orchid, Dendrobium aphyllum (Orchidaceae).
authors: ['Zi XM', 'Sheng CL', 'Goodale UM', 'Shao SC', 'Gao JY']
source: Mycorrhiza. 2014 Oct;24(7):487-99. doi: 10.1007/s00572-014-0565-8. Epub 2014 Feb 23.

title: Combination of vildagliptin and rosiglitazone ameliorates nonalcoholic fatty liver disease in C57BL/6 mice.
authors: ['Mookkan J', 'De S', 'Shetty P', 'Kulkarni NM', 'Devisingh V', 'Jaji MS', 'Lakshmi VP', 'Chaudhary S', 'Kulathingal J', 'Rajesh NB', 'Narayanan S']
source: Indian J Pharmacol. 2014 Jan-Feb;46(1):46-50. doi: 10.4103/0253-7613.125166.

title: The colonization patterns of different fungi on roots of Cymbidium hybridum plantlets and their respective inoculation effects on growth and nutrient uptake of orchid plantlets.
authors: ['Zhao XL', 'Yang JZ', 'Liu S', 'Chen CL', 'Zhu HY', 'Cao JX']
source: World J Microbiol Biotechnol. 2014 Jul;30(7):1993-2003. doi: 10.1007/s11274-014-1623-2. Epub 2014 Feb 16.

title: Pollinator specificity drives strong prepollination reproductive isolation in sympatric sexually deceptive orchids.
authors: ['Whitehead MR', 'Peakall R']
source: Evolution. 2014 Jun;68(6):1561-75. doi: 10.1111/evo.12382. Epub 2014 Mar 26.

title: Floral scent emitted by white and coloured morphs in orchids.
authors: ['Dormont L', 'Delle-Vedove R', 'Bessiere JM', 'Schatz B']
source: Phytochemistry. 2014 Apr;100:51-9. doi: 10.1016/j.phytochem.2014.01.009. Epub 2014 Feb 10.

title: HIV risk behaviors of male injecting drug users and associated non-condom use with regular female sexual partners in north-east India.
authors: ['Mishra RK', 'Ganju D', 'Ramesh S', 'Lalmuanpuii M', 'Biangtung L', 'Humtsoe C', 'Saggurti N']
source: Harm Reduct J. 2014 Feb 13;11:5. doi: 10.1186/1477-7517-11-5.

title: Antimicrobial activity of cold and hot successive pseudobulb extracts of Flickingeria nodosa (Dalz.) Seidenf.
authors: ['Nagananda GS', 'Satishchandra N']
source: Pak J Biol Sci. 2013 Oct 15;16(20):1189-93.

title: Evidence for isolation-by-habitat among populations of an epiphytic orchid species on a small oceanic island.
authors: ['Mallet B', 'Martos F', 'Blambert L', 'Pailler T', 'Humeau L']
source: PLoS One. 2014 Feb 3;9(2):e87469. doi: 10.1371/journal.pone.0087469. eCollection 2014.

title: Stable isotope cellular imaging reveals that both live and degenerating fungal pelotons transfer carbon and nitrogen to orchid protocorms.
authors: ['Kuga Y', 'Sakamoto N', 'Yurimoto H']
source: New Phytol. 2014 Apr;202(2):594-605. doi: 10.1111/nph.12700. Epub 2014 Feb 3.

title: Isolation and characterisation of degradation impurities in the cefazolin sodium drug substance.
authors: ['Sivakumar B', 'Parthasarathy K', 'Murugan R', 'Jeyasudha R', 'Murugan S', 'Saranghdar RJ']
source: Sci Pharm. 2013 Jun 4;81(4):933-50. doi: 10.3797/scipharm.1304-14. eCollection 2013 Dec.

title: Antimycobacterial evaluation of novel hybrid arylidene thiazolidine-2,4-diones.
authors: ['Ponnuchamy S', 'Kanchithalaivan S', 'Ranjith Kumar R', 'Ali MA', 'Choon TS']
source: Bioorg Med Chem Lett. 2014 Feb 15;24(4):1089-93. doi: 10.1016/j.bmcl.2014.01.007. Epub 2014 Jan 11.

title: A framework for assessing supply-side wildlife conservation.
authors: ['Phelps J', 'Carrasco LR', 'Webb EL']
source: Conserv Biol. 2014 Feb;28(1):244-57. doi: 10.1111/cobi.12160. Epub 2013 Nov 1.

title: Impact of primer choice on characterization of orchid mycorrhizal communities using 454 pyrosequencing.
authors: ['Waud M', 'Busschaert P', 'Ruyters S', 'Jacquemyn H', 'Lievens B']
source: Mol Ecol Resour. 2014 Jul;14(4):679-99. doi: 10.1111/1755-0998.12229. Epub 2014 Mar 14.

title: 3-Isopropyl-1-{2-[(1-methyl-1H-tetra-zol-5-yl)sulfan-yl]acet-yl}-2,6-di-phenyl-pi peridin-4-one hemihydrate.
authors: ['Ganesan S', 'Sugumar P', 'Ananthan S', 'Ponnuswamy MN']
source: Acta Crystallogr Sect E Struct Rep Online. 2013 Oct 2;69(Pt 11):o1598. doi: 10.1107/S1600536813026500. eCollection 2013 Oct 2.

title: Carbon and nitrogen gain during the growth of orchid seedlings in nature.
authors: ['Stockel M', 'Tesitelova T', 'Jersakova J', 'Bidartondo MI', 'Gebauer G']
source: New Phytol. 2014 Apr;202(2):606-15. doi: 10.1111/nph.12688. Epub 2014 Jan 21.

title: Growth promotion-related miRNAs in Oncidium orchid roots colonized by the endophytic fungus Piriformospora indica.
authors: ['Ye W', 'Shen CH', 'Lin Y', 'Chen PJ', 'Xu X', 'Oelmuller R', 'Yeh KW', 'Lai Z']
source: PLoS One. 2014 Jan 7;9(1):e84920. doi: 10.1371/journal.pone.0084920. eCollection 2014.

title: Seedling development and evaluation of genetic stability of cryopreserved Dendrobium hybrid mature seeds.
authors: ['Galdiano RF Jr', 'de Macedo Lemos EG', 'de Faria RT', 'Vendrame WA']
source: Appl Biochem Biotechnol. 2014 Mar;172(5):2521-9. doi: 10.1007/s12010-013-0699-8. Epub 2014 Jan 10.

title: Systematic revision of Platanthera in the Azorean archipelago: not one but three species, including arguably Europe's rarest orchid.
authors: ['Bateman RM', 'Rudall PJ', 'Moura M']
source: PeerJ. 2013 Dec 10;1:e218. doi: 10.7717/peerj.218. eCollection 2013.

title: Deep sequencing-based analysis of the Cymbidium ensifolium floral transcriptome.
authors: ['Li X', 'Luo J', 'Yan T', 'Xiang L', 'Jin F', 'Qin D', 'Sun C', 'Xie M']
source: PLoS One. 2013 Dec 31;8(12):e85480. doi: 10.1371/journal.pone.0085480. eCollection 2013.

title: Pyrazines Attract Catocheilus Thynnine Wasps.
authors: ['Bohman B', 'Peakall R']
source: Insects. 2014 Jun 19;5(2):474-87. doi: 10.3390/insects5020474.

title: Comparison of hypoglycemic and antioxidative effects of polysaccharides from four different Dendrobium species.
authors: ['Pan LH', 'Li XF', 'Wang MN', 'Zha XQ', 'Yang XF', 'Liu ZJ', 'Luo YB', 'Luo JP']
source: Int J Biol Macromol. 2014 Mar;64:420-7. doi: 10.1016/j.ijbiomac.2013.12.024. Epub 2013 Dec 24.

title: Caught in the act: pollination of sexually deceptive trap-flowers by fungus gnats in Pterostylis (Orchidaceae).
authors: ['Phillips RD', 'Scaccabarozzi D', 'Retter BA', 'Hayes C', 'Brown GR', 'Dixon KW', 'Peakall R']
source: Ann Bot. 2014 Mar;113(4):629-41. doi: 10.1093/aob/mct295. Epub 2013 Dec 22.

title: Pollinator deception in the orchid mantis.
authors: ["O'Hanlon JC", 'Holwell GI', 'Herberstein ME']
source: Am Nat. 2014 Jan;183(1):126-32. doi: 10.1086/673858. Epub 2013 Sep 23.

title: Coexisting orchid species have distinct mycorrhizal communities and display strong spatial segregation.
authors: ['Jacquemyn H', 'Brys R', 'Merckx VS', 'Waud M', 'Lievens B', 'Wiegand T']
source: New Phytol. 2014 Apr;202(2):616-27. doi: 10.1111/nph.12640. Epub 2013 Dec 11.

title: Structurally characterized arabinogalactan from Anoectochilus formosanus as an immuno-modulator against CT26 colon cancer in BALB/c mice.
authors: ['Yang LC', 'Hsieh CC', 'Lu TJ', 'Lin WC']
source: Phytomedicine. 2014 Apr 15;21(5):647-55. doi: 10.1016/j.phymed.2013.10.032. Epub 2013 Dec 4.

title: Proteome changes in Oncidium sphacelatum (Orchidaceae) at different trophic stages of symbiotic germination.
authors: ['Valadares RB', 'Perotto S', 'Santos EC', 'Lambais MR']
source: Mycorrhiza. 2014 Jul;24(5):349-60. doi: 10.1007/s00572-013-0547-2. Epub 2013 Dec 6.

title: First flowering hybrid between autotrophic and mycoheterotrophic plant species: breakthrough in molecular biology of mycoheterotrophy.
authors: ['Ogura-Tsujita Y', 'Miyoshi K', 'Tsutsumi C', 'Yukawa T']
source: J Plant Res. 2014 Mar;127(2):299-305. doi: 10.1007/s10265-013-0612-0. Epub 2013 Dec 6.

title: Relative importance of pollen and seed dispersal across a Neotropical mountain landscape for an epiphytic orchid.
authors: ['Kartzinel TR', 'Shefferson RP', 'Trapnell DW']
source: Mol Ecol. 2013 Dec;22(24):6048-59. doi: 10.1111/mec.12551. Epub 2013 Nov 8.

title: DNA barcoding of Orchidaceae in Korea.
authors: ['Kim HM', 'Oh SH', 'Bhandari GS', 'Kim CS', 'Park CW']
source: Mol Ecol Resour. 2014 May;14(3):499-507. doi: 10.1111/1755-0998.12207. Epub 2013 Dec 16.

title: A modified ABCDE model of flowering in orchids based on gene expression profiling studies of the moth orchid Phalaenopsis aphrodite.
authors: ['Su CL', 'Chen WC', 'Lee AY', 'Chen CY', 'Chang YC', 'Chao YT', 'Shih MC']
source: PLoS One. 2013 Nov 12;8(11):e80462. doi: 10.1371/journal.pone.0080462. eCollection 2013.

title: Mycorrhizal preferences and fine spatial structure of the epiphytic orchid Epidendrum rhopalostele.
authors: ['Riofrio ML', 'Cruz D', 'Torres E', 'de la Cruz M', 'Iriondo JM', 'Suarez JP']
source: Am J Bot. 2013 Dec;100(12):2339-48. doi: 10.3732/ajb.1300069. Epub 2013 Nov 19.

title: Combining microtomy and confocal laser scanning microscopy for structural analyses of plant-fungus associations.
authors: ['Rath M', 'Grolig F', 'Haueisen J', 'Imhof S']
source: Mycorrhiza. 2014 May;24(4):293-300. doi: 10.1007/s00572-013-0530-y. Epub 2013 Nov 19.

title: High-resolution secondary ion mass spectrometry analysis of carbon dynamics in mycorrhizas formed by an obligately myco-heterotrophic orchid.
authors: ['Bougoure J', 'Ludwig M', 'Brundrett M', 'Cliff J', 'Clode P', 'Kilburn M', 'Grierson P']
source: Plant Cell Environ. 2014 May;37(5):1223-30. doi: 10.1111/pce.12230. Epub 2013 Dec 12.

title: Donkey orchid symptomless virus: a viral 'platypus' from Australian terrestrial orchids.
authors: ['Wylie SJ', 'Li H', 'Jones MG']
source: PLoS One. 2013 Nov 5;8(11):e79587. doi: 10.1371/journal.pone.0079587. eCollection 2013.

title: Genome-wide annotation, expression profiling, and protein interaction studies of the core cell-cycle genes in Phalaenopsis aphrodite.
authors: ['Lin HY', 'Chen JC', 'Wei MJ', 'Lien YC', 'Li HH', 'Ko SS', 'Liu ZH', 'Fang SC']
source: Plant Mol Biol. 2014 Jan;84(1-2):203-26. doi: 10.1007/s11103-013-0128-y. Epub 2013 Sep 25.

title: Effect of plasmolysis on protocorm-like bodies of Dendrobium Bobby Messina orchid following cryopreservation with encapsulation-dehydration method.
authors: ['Antony JJ', 'Mubbarakh SA', 'Mahmood M', 'Subramaniam S']
source: Appl Biochem Biotechnol. 2014 Feb;172(3):1433-44. doi: 10.1007/s12010-013-0636-x. Epub 2013 Nov 12.

title: The orchid-bee fauna (Hymenoptera: Apidae) of 'RPPN Feliciano Miguel Abdala' revisited: relevant changes in community composition.
authors: ['Nemesio A', 'Paula IR']
source: Braz J Biol. 2013 Aug;73(3):515-20. doi: 10.1590/S1519-69842013000300008.

title: Community of orchid bees (Hymenoptera: Apidae) in transitional vegetation between Cerrado and Atlantic Forest in southeastern Brazil.
authors: ['Pires EP', 'Morgado LN', 'Souza B', 'Carvalho CF', 'Nemesio A']
source: Braz J Biol. 2013 Aug;73(3):507-13. doi: 10.1590/S1519-69842013000300007.

title: The AP2-like gene OitaAP2 is alternatively spliced and differentially expressed in inflorescence and vegetative tissues of the orchid Orchis italica.
authors: ['Salemme M', 'Sica M', 'Iazzetti G', 'Gaudio L', 'Aceto S']
source: PLoS One. 2013 Oct 21;8(10):e77454. doi: 10.1371/journal.pone.0077454. eCollection 2013.

title: Identification and characterization of the microRNA transcriptome of a moth orchid Phalaenopsis aphrodite.
authors: ['Chao YT', 'Su CL', 'Jean WH', 'Chen WC', 'Chang YC', 'Shih MC']
source: Plant Mol Biol. 2014 Mar;84(4-5):529-48. doi: 10.1007/s11103-013-0150-0. Epub 2013 Oct 31.

title: [Some aspects of underground organs of spotleaf orchis growth and phenolic compound accumulation at the generative stage of ontogenesis].
authors: ['Marakaev OA', 'Tselebrovskii MV', 'Nikolaeva TN', 'Zagoskina NV']
source: Izv Akad Nauk Ser Biol. 2013 May-Jun;(3):315-23.

title: Floral elaiophores in Lockhartia Hook. (Orchidaceae: Oncidiinae): their distribution, diversity and anatomy.
authors: ['Blanco MA', 'Davies KL', 'Stpiczynska M', 'Carlsward BS', 'Ionta GM', 'Gerlach G']
source: Ann Bot. 2013 Dec;112(9):1775-91. doi: 10.1093/aob/mct232. Epub 2013 Oct 29.

title: Pollinator shifts and the evolution of spur length in the moth-pollinated orchid Platanthera bifolia.
authors: ['Boberg E', 'Alexandersson R', 'Jonsson M', 'Maad J', 'Agren J', 'Nilsson LA']
source: Ann Bot. 2014 Jan;113(2):267-75. doi: 10.1093/aob/mct217. Epub 2013 Oct 29.

title: Conservation value and permeability of neotropical oil palm landscapes for orchid bees.
authors: ['Livingston G', 'Jha S', 'Vega A', 'Gilbert L']
source: PLoS One. 2013 Oct 17;8(10):e78523. doi: 10.1371/journal.pone.0078523. eCollection 2013.

title: First records and description of metallic red females of Euglossa (Alloglossura) gorgonensis Cheesman, with notes on color variation within the species (Hymenoptera, Apidae).
authors: ['Hinojosa-Diaz IA', 'Brosi BJ']
source: Zookeys. 2013 Sep 25;(335):113-9. doi: 10.3897/zookeys.335.6134. eCollection 2013.

title: Cryopreservation of Brassidium Shooting Star orchid using the PVS3 method supported with preliminary histological analysis.
authors: ['Mubbarakh SA', 'Rahmah S', 'Rahman ZA', 'Sah NN', 'Subramaniam S']
source: Appl Biochem Biotechnol. 2014 Jan;172(2):1131-45. doi: 10.1007/s12010-013-0597-0. Epub 2013 Oct 23.

title: Niche conservatism and the future potential range of Epipactis helleborine (Orchidaceae).
authors: ['Kolanowska M']
source: PLoS One. 2013 Oct 15;8(10):e77352. doi: 10.1371/journal.pone.0077352. eCollection 2013.

title: Orchid protocorm-like bodies are somatic embryos.
authors: ['Lee YI', 'Hsu ST', 'Yeung EC']
source: Am J Bot. 2013 Nov;100(11):2121-31. doi: 10.3732/ajb.1300193. Epub 2013 Oct 17.

title: Genetic diversity and population differentiation of Calanthe tsoongiana, a rare and endemic orchid in China.
authors: ['Qian X', 'Wang CX', 'Tian M']
source: Int J Mol Sci. 2013 Oct 14;14(10):20399-413. doi: 10.3390/ijms141020399.

title: Highly diverse and spatially heterogeneous mycorrhizal symbiosis in a rare epiphyte is unrelated to broad biogeographic or environmental features.
authors: ['Kartzinel TR', 'Trapnell DW', 'Shefferson RP']
source: Mol Ecol. 2013 Dec;22(23):5949-61. doi: 10.1111/mec.12536. Epub 2013 Nov 6.

title: The IGSF1 deficiency syndrome: characteristics of male and female patients.
authors: ['Joustra SD', 'Schoenmakers N', 'Persani L', 'Campi I', 'Bonomi M', 'Radetti G', 'Beck-Peccoz P', 'Zhu H', 'Davis TM', 'Sun Y', 'Corssmit EP', 'Appelman-Dijkstra NM', 'Heinen CA', 'Pereira AM', 'Varewijck AJ', 'Janssen JA', 'Endert E', 'Hennekam RC', 'Lombardi MP', 'Mannens MM', 'Bak B', 'Bernard DJ', 'Breuning MH', 'Chatterjee K', 'Dattani MT', 'Oostdijk W', 'Biermasz NR', 'Wit JM', 'van Trotsenburg AS']
source: J Clin Endocrinol Metab. 2013 Dec;98(12):4942-52. doi: 10.1210/jc.2013-2743. Epub 2013 Oct 9.

title: A pollinator shift explains floral divergence in an orchid species complex in South Africa.
authors: ['Peter CI', 'Johnson SD']
source: Ann Bot. 2014 Jan;113(2):277-88. doi: 10.1093/aob/mct216. Epub 2013 Oct 9.

title: Floral adaptation to local pollinator guilds in a terrestrial orchid.
authors: ['Sun M', 'Gross K', 'Schiestl FP']
source: Ann Bot. 2014 Jan;113(2):289-300. doi: 10.1093/aob/mct219. Epub 2013 Oct 9.

title: Challenges and prospects in the telemetry of insects.
authors: ['Daniel Kissling W', 'Pattemore DE', 'Hagen M']
source: Biol Rev Camb Philos Soc. 2014 Aug;89(3):511-30. doi: 10.1111/brv.12065. Epub 2013 Oct 8.

title: Identification and characterization of process-related impurities of trans-resveratrol.
authors: ['Sivakumar B', 'Murugan R', 'Baskaran A', 'Khadangale BP', 'Murugan S', 'Senthilkumar UP']
source: Sci Pharm. 2013 Mar 17;81(3):683-95. doi: 10.3797/scipharm.1301-17. eCollection 2013.

title: Vanilla--its science of cultivation, curing, chemistry, and nutraceutical properties.
authors: ['Anuradha K', 'Shyamala BN', 'Naidu MM']
source: Crit Rev Food Sci Nutr. 2013;53(12):1250-76. doi: 10.1080/10408398.2011.563879.

title: Dichorhavirus: a proposed new genus for Brevipalpus mite-transmitted, nuclear, bacilliform, bipartite, negative-strand RNA plant viruses.
authors: ['Dietzgen RG', 'Kuhn JH', 'Clawson AN', 'Freitas-Astua J', 'Goodin MM', 'Kitajima EW', 'Kondo H', 'Wetzel T', 'Whitfield AE']
source: Arch Virol. 2014 Mar;159(3):607-19. doi: 10.1007/s00705-013-1834-0. Epub 2013 Oct 1.

title: Moscatilin induces apoptosis and mitotic catastrophe in human esophageal cancer cells.
authors: ['Chen CA', 'Chen CC', 'Shen CC', 'Chang HH', 'Chen YJ']
source: J Med Food. 2013 Oct;16(10):869-77. doi: 10.1089/jmf.2012.2617. Epub 2013 Sep 27.

title: Composition of Cypripedium calceolus (Orchidaceae) seeds analyzed by attenuated total reflectance IR spectroscopy: in search of understanding longevity in the ground.
authors: ['Barsberg S', 'Rasmussen HN', 'Kodahl N']
source: Am J Bot. 2013 Oct;100(10):2066-73. doi: 10.3732/ajb.1200646. Epub 2013 Sep 26.

title: Perspectives on MADS-box expression during orchid flower evolution and development.
authors: ['Mondragon-Palomino M']
source: Front Plant Sci. 2013 Sep 23;4:377. doi: 10.3389/fpls.2013.00377. eCollection 2013.

title: Simple-sequence repeat markers of Cattleya coccinea (Orchidaceae), an endangered species of the Brazilian Atlantic Forest.
authors: ['Novello M', 'Rodrigues JF', 'Pinheiro F', 'Oliveira GC', 'Veasey EA', 'Koehler S']
source: Genet Mol Res. 2013 Sep 3;12(3):3274-8. doi: 10.4238/2013.September.3.3.

title: Floral odour chemistry defines species boundaries and underpins strong reproductive isolation in sexually deceptive orchids.
authors: ['Peakall R', 'Whitehead MR']
source: Ann Bot. 2014 Jan;113(2):341-55. doi: 10.1093/aob/mct199. Epub 2013 Sep 19.

title: Identification and symbiotic ability of Psathyrellaceae fungi isolated from a photosynthetic orchid, Cremastra appendiculata (Orchidaceae).
authors: ['Yagame T', 'Funabiki E', 'Nagasawa E', 'Fukiharu T', 'Iwase K']
source: Am J Bot. 2013 Sep;100(9):1823-30. doi: 10.3732/ajb.1300099. Epub 2013 Sep 11.

title: Promoting role of an endophyte on the growth and contents of kinsenosides and flavonoids of Anoectochilus formosanus Hayata, a rare and threatened medicinal Orchidaceae plant.
authors: ['Zhang FS', 'Lv YL', 'Zhao Y', 'Guo SX']
source: J Zhejiang Univ Sci B. 2013 Sep;14(9):785-92. doi: 10.1631/jzus.B1300056.

title: Collection and trade of wild-harvested orchids in Nepal.
authors: ['Subedi A', 'Kunwar B', 'Choi Y', 'Dai Y', 'van Andel T', 'Chaudhary RP', 'de Boer HJ', 'Gravendeel B']
source: J Ethnobiol Ethnomed. 2013 Aug 31;9(1):64. doi: 10.1186/1746-4269-9-64.

title: Direct detection of orchid viruses using nanorod-based fiber optic particle plasmon resonance immunosensor.
authors: ['Lin HY', 'Huang CH', 'Lu SH', 'Kuo IT', 'Chau LK']
source: Biosens Bioelectron. 2014 Jan 15;51:371-8. doi: 10.1016/j.bios.2013.08.009. Epub 2013 Aug 17.

title: The evolution of floral nectaries in Disa (Orchidaceae: Disinae): recapitulation or diversifying innovation?
authors: ['Hobbhahn N', 'Johnson SD', 'Bytebier B', 'Yeung EC', 'Harder LD']
source: Ann Bot. 2013 Nov;112(7):1303-19. doi: 10.1093/aob/mct197. Epub 2013 Aug 29.

title: [Molecular cloning and characterization of S-adenosyl-L-methionine decarboxylase gene (DoSAMDC1) in Dendrobium officinale].
authors: ['Zhao MM', 'Zhang G', 'Zhang DW', 'Guo SX']
source: Yao Xue Xue Bao. 2013 Jun;48(6):946-52.

title: Preliminary genetic linkage maps of Chinese herb Dendrobium nobile and D. moniliforme.
authors: ['Feng S', 'Zhao H', 'Lu J', 'Liu J', 'Shen B', 'Wang H']
source: J Genet. 2013;92(2):205-12.

title: Evidence of separate karyotype evolutionary pathway in Euglossa orchid bees by cytogenetic analyses.
authors: ['Fernandes A', 'Werneck HA', 'Pompolo SG', 'Lopes DM']
source: An Acad Bras Cienc. 2013 Sep;85(3):937-44. doi: 10.1590/S0001-37652013005000050.

title: Histological and micro-CT evidence of stigmatic rostellum receptivity promoting auto-pollination in the madagascan orchid Bulbophyllum bicoloratum.
authors: ['Gamisch A', 'Staedler YM', 'Schonenberger J', 'Fischer GA', 'Comes HP']
source: PLoS One. 2013 Aug 13;8(8):e72688. doi: 10.1371/journal.pone.0072688. eCollection 2013.

title: Virus-induced gene silencing unravels multiple transcription factors involved in floral growth and development in Phalaenopsis orchids.
authors: ['Hsieh MH', 'Pan ZJ', 'Lai PH', 'Lu HC', 'Yeh HH', 'Hsu CC', 'Wu WL', 'Chung MC', 'Wang SS', 'Chen WH', 'Chen HH']
source: J Exp Bot. 2013 Sep;64(12):3869-84. doi: 10.1093/jxb/ert218.

title: Habitat fragmentation effects on the orchid bee communities in remnant forests of southeastern Brazil.
authors: ['Knoll Fdo R', 'Penatti NC']
source: Neotrop Entomol. 2012 Oct;41(5):355-65. doi: 10.1007/s13744-012-0057-5. Epub 2012 Jun 29.

title: Spatial-temporal variation in orchid bee communities (Hymenoptera: Apidae) in remnants of arboreal Caatinga in the Chapada Diamantina region, state of Bahia, Brazil.
authors: ['Andrade-Silva AC', 'Nemesio A', 'de Oliveira FF', 'Nascimento FS']
source: Neotrop Entomol. 2012 Aug;41(4):296-305. doi: 10.1007/s13744-012-0053-9. Epub 2012 Jun 26.

title: Old Fragments of Forest Inside an Urban Area Are Able to Keep Orchid Bee (Hymenoptera: Apidae: Euglossini) Assemblages? The Case of a Brazilian Historical City.
authors: ['Ferreira RP', 'Martins C', 'Dutra MC', 'Mentone CB', 'Antonini Y']
source: Neotrop Entomol. 2013 Jul 16.

title: The ecological basis for biogeographic classification: an example in orchid bees (Apidae: Euglossini).
authors: ['Parra-H A', 'Nates-Parra G']
source: Neotrop Entomol. 2012 Dec;41(6):442-9. doi: 10.1007/s13744-012-0069-1. Epub 2012 Aug 24.

title: Benefits to rare plants and highway safety from annual population reductions of a "native invader," white-tailed deer, in a Chicago-area woodland.
authors: ['Engeman RM', 'Guerrant T', 'Dunn G', 'Beckerman SF', 'Anchor C']
source: Environ Sci Pollut Res Int. 2014 Jan;21(2):1592-7. doi: 10.1007/s11356-013-2056-4. Epub 2013 Aug 14.

title: Start Codon Targeted (SCoT) marker reveals genetic diversity of Dendrobium nobile Lindl., an endangered medicinal orchid species.
authors: ['Bhattacharyya P', 'Kumaria S', 'Kumar S', 'Tandon P']
source: Gene. 2013 Oct 15;529(1):21-6. doi: 10.1016/j.gene.2013.07.096. Epub 2013 Aug 11.

title: Vegetation context influences the strength and targets of pollinator-mediated selection in a deceptive orchid.
authors: ['Sletvold N', 'Grindeland JM', 'Agren J']
source: Ecology. 2013 Jun;94(6):1236-42.

title: Pollination and floral ecology of Arundina graminifolia (Orchidaceae) at the northern border of the species' natural distribution.
authors: ['Sugiura N']
source: J Plant Res. 2014;127(1):131-9. doi: 10.1007/s10265-013-0587-x. Epub 2013 Aug 7.

title: The orchid-bee faunas (Hymenoptera: Apidae) of 'Parque Nacional do Monte Pascoal', 'Parque Nacional do Descobrimento' and three other Atlantic Forest remnants in southern Bahia, eastern Brazil.
authors: ['Nemesio A']
source: Braz J Biol. 2013 May;73(2):437-46. doi: 10.1590/S1519-69842013000200028.

title: The orchid-bee faunas (Hymenoptera: Apidae) of two Atlantic Forest remnants in southern Bahia, eastern Brazil.
authors: ['Nemesio A']
source: Braz J Biol. 2013 May;73(2):375-81. doi: 10.1590/S1519-69842013000200018.

title: Are orchid bees at risk? First comparative survey suggests declining populations of forest-dependent species.
authors: ['Nemesio A']
source: Braz J Biol. 2013 May;73(2):367-74. doi: 10.1590/S1519-69842013000200017.

title: The orchid-bee fauna (Hymenoptera: Apidae) of 'Reserva Biologica de Una', a hotspot in the Atlantic Forest of southern Bahia, eastern Brazil.
authors: ['Nemesio A']
source: Braz J Biol. 2013 May;73(2):347-52. doi: 10.1590/S1519-69842013000200014.

title: Ancestral deceit and labile evolution of nectar production in the African orchid genus Disa.
authors: ['Johnson SD', 'Hobbhahn N', 'Bytebier B']
source: Biol Lett. 2013 Jul 31;9(5):20130500. doi: 10.1098/rsbl.2013.0500. Print 2013 Oct 23.

title: Orchid bee (Hymenoptera: Apidae) community from a gallery forest in the Brazilian Cerrado.
authors: ['Silva FS']
source: Rev Biol Trop. 2012 Jun;60(2):625-33.

title: Genome assembly of citrus leprosis virus nuclear type reveals a close association with orchid fleck virus.
authors: ['Roy A', 'Stone A', 'Otero-Colina G', 'Wei G', 'Choudhary N', 'Achor D', 'Shao J', 'Levy L', 'Nakhla MK', 'Hollingsworth CR', 'Hartung JS', 'Schneider WL', 'Brlansky RH']
source: Genome Announc. 2013 Jul 25;1(4). pii: e00519-13. doi: 10.1128/genomeA.00519-13.

title: Complete genome sequence of Habenaria mosaic virus, a new potyvirus infecting a terrestrial orchid (Habenaria radiata) in Japan.
authors: ['Kondo H', 'Maeda T', 'Gara IW', 'Chiba S', 'Maruyama K', 'Tamada T', 'Suzuki N']
source: Arch Virol. 2014 Jan;159(1):163-6. doi: 10.1007/s00705-013-1784-6. Epub 2013 Jul 16.

title: Modulation of physical environment makes placental mesenchymal stromal cells suitable for therapy.
authors: ['Mathew SA', 'Rajendran S', 'Gupta PK', 'Bhonde R']
source: Cell Biol Int. 2013 Nov;37(11):1197-204. doi: 10.1002/cbin.10154. Epub 2013 Aug 13.

title: Genetic inference of epiphytic orchid colonization; it may only take one.
authors: ['Trapnell DW', 'Hamrick JL', 'Ishibashi CD', 'Kartzinel TR']
source: Mol Ecol. 2013 Jul;22(14):3680-92. doi: 10.1111/mec.12338.

title: Microbial diversity in the floral nectar of seven Epipactis (Orchidaceae) species.
authors: ['Jacquemyn H', 'Lenaerts M', 'Tyteca D', 'Lievens B']
source: Microbiologyopen. 2013 Aug;2(4):644-58. doi: 10.1002/mbo3.103. Epub 2013 Jul 8.

title: [Sequence analysis of LEAFY homologous gene from Dendrobium moniliforme and application for identification of medicinal Dendrobium].
authors: ['Xing WR', 'Hou BW', 'Guan JJ', 'Luo J', 'Ding XY']
source: Yao Xue Xue Bao. 2013 Apr;48(4):597-603.

title: Components of reproductive isolation between Orchis mascula and Orchis pauciflora.
authors: ['Scopece G', 'Croce A', 'Lexer C', 'Cozzolino S']
source: Evolution. 2013 Jul;67(7):2083-93. doi: 10.1111/evo.12091. Epub 2013 Mar 29.

title: Phylogeographic structure and outbreeding depression reveal early stages of reproductive isolation in the neotropical orchid Epidendrum denticulatum.
authors: ['Pinheiro F', 'Cozzolino S', 'de Barros F', 'Gouveia TM', 'Suzuki RM', 'Fay MF', 'Palma-Silva C']
source: Evolution. 2013 Jul;67(7):2024-39. doi: 10.1111/evo.12085. Epub 2013 Mar 21.

title: Asymbiotic seed germination and in vitro conservation of Coelogyne nervosa A. Rich. an endemic orchid to Western Ghats.
authors: ['Abraham S', 'Augustine J', 'Thomas TD']
source: Physiol Mol Biol Plants. 2012 Jul;18(3):245-51. doi: 10.1007/s12298-012-0118-6.

title: Endophytic and mycorrhizal fungi associated with roots of endangered native orchids from the Atlantic Forest, Brazil.
authors: ['Oliveira SF', 'Bocayuva MF', 'Veloso TG', 'Bazzolli DM', 'da Silva CC', 'Pereira OL', 'Kasuya MC']
source: Mycorrhiza. 2014 Jan;24(1):55-64. doi: 10.1007/s00572-013-0512-0. Epub 2013 Jun 30.

title: Convergent evolution of floral signals underlies the success of Neotropical orchids.
authors: ['Papadopulos AS', 'Powell MP', 'Pupulin F', 'Warner J', 'Hawkins JA', 'Salamin N', 'Chittka L', 'Williams NH', 'Whitten WM', 'Loader D', 'Valente LM', 'Chase MW', 'Savolainen V']
source: Proc Biol Sci. 2013 Jun 26;280(1765):20130960. doi: 10.1098/rspb.2013.0960. Print 2013 Aug 22.

title: 3,3'-{[(Biphenyl-2,2'-di-yl)bis-(methyl-ene)]bis-(-oxy)}bis-[N-(4-chloro-phen-yl) benzamide].
authors: ['Rajadurai R', 'Padmanabhan R', 'Meenakshi Sundaram SS', 'Ananthan S']
source: Acta Crystallogr Sect E Struct Rep Online. 2013 May 18;69(Pt 6):o914-5. doi: 10.1107/S160053681301009X. Print 2013 Jun 1.

title: 3,5-Dimethyl-1-{2-[(5-methyl-1,3,4-thia-diazol-2-yl)sulfan-yl]acet-yl}-2,6-diphen ylpiperidin-4-one.
authors: ['Ganesan S', 'Sugumar P', 'Ananthan S', 'Ponnuswamy MN']
source: Acta Crystallogr Sect E Struct Rep Online. 2013 May 11;69(Pt 6):o845. doi: 10.1107/S1600536813012014. Print 2013 Jun 1.

title: Symbiotic seed germination and protocorm development of Aa achalensis Schltr., a terrestrial orchid endemic from Argentina.
authors: ['Sebastian F', 'Vanesa S', 'Eduardo F', 'Graciela T', 'Silvana S']
source: Mycorrhiza. 2014 Jan;24(1):35-43. doi: 10.1007/s00572-013-0510-2. Epub 2013 Jun 20.

title: [Sibling species of rein orchid (Gymnadenia:Orchidaceae, Magnoliophyta) in Russia].
authors: ['Efimov PG']
source: Genetika. 2013 Mar;49(3):343-54.

title: Detection of viruses directly from the fresh leaves of a Phalaenopsis orchid using a microfluidic system.
authors: ['Chang WH', 'Yang SY', 'Lin CL', 'Wang CH', 'Li PC', 'Chen TY', 'Jan FJ', 'Lee GB']
source: Nanomedicine. 2013 Nov;9(8):1274-82. doi: 10.1016/j.nano.2013.05.016. Epub 2013 Jun 8.

title: Floral visual signal increases reproductive success in a sexually deceptive orchid.
authors: ['Rakosy D', 'Streinzer M', 'Paulus HF', 'Spaethe J']
source: Arthropod Plant Interact. 2012 Dec 1;6(4):671-681.

title: Moscatilin inhibits lung cancer cell motility and invasion via suppression of endogenous reactive oxygen species.
authors: ['Kowitdamrong A', 'Chanvorachote P', 'Sritularak B', 'Pongrakhananon V']
source: Biomed Res Int. 2013;2013:765894. doi: 10.1155/2013/765894. Epub 2013 May 8.

title: Transcriptome and proteome data reveal candidate genes for pollinator attraction in sexually deceptive orchids.
authors: ['Sedeek KE', 'Qi W', 'Schauer MA', 'Gupta AK', 'Poveda L', 'Xu S', 'Liu ZJ', 'Grossniklaus U', 'Schiestl FP', 'Schluter PM']
source: PLoS One. 2013 May 29;8(5):e64621. doi: 10.1371/journal.pone.0064621. Print 2013.

title: Beyond orchids and dandelions: testing the 5-HTT "risky" allele for evidence of phenotypic capacitance and frequency-dependent selection.
authors: ['Conley D', 'Rauscher E', 'Siegal ML']
source: Biodemography Soc Biol. 2013;59(1):37-56. doi: 10.1080/19485565.2013.774620.

title: Molecular cloning and spatiotemporal expression of an APETALA1/FRUITFULL-like MADS-box gene from the orchid (Cymbidium faberi).
authors: ['Tian Y', 'Yuan X', 'Jiang S', 'Cui B', 'Su J']
source: Sheng Wu Gong Cheng Xue Bao. 2013 Feb;29(2):203-13.

title: Antigenotoxic effect, composition and antioxidant activity of Dendrobium speciosum.
authors: ['Moretti M', 'Cossignani L', 'Messina F', 'Dominici L', 'Villarini M', 'Curini M', 'Marcotullio MC']
source: Food Chem. 2013 Oct 15;140(4):660-5. doi: 10.1016/j.foodchem.2012.10.022. Epub 2012 Nov 2.

title: Exposure to HIV prevention programmes associated with improved condom use and uptake of HIV testing by female sex workers in Nagaland, Northeast India.
authors: ['Armstrong G', 'Medhi GK', 'Kermode M', 'Mahanta J', 'Goswami P', 'Paranjape R']
source: BMC Public Health. 2013 May 15;13:476. doi: 10.1186/1471-2458-13-476.

title: Significant spatial aggregation and fine-scale genetic structure in the homosporous fern Cyrtomium falcatum (Dryopteridaceae).
authors: ['Chung MY', 'Chung MG']
source: New Phytol. 2013 Aug;199(3):663-72. doi: 10.1111/nph.12293. Epub 2013 May 7.

title: Catalase and superoxide dismutase activities and the total protein content of protocorm-like bodies of Dendrobium sonia-28 subjected to vitrification.
authors: ['Poobathy R', 'Sinniah UR', 'Xavier R', 'Subramaniam S']
source: Appl Biochem Biotechnol. 2013 Jul;170(5):1066-79. doi: 10.1007/s12010-013-0241-z. Epub 2013 May 3.

title: Organ homologies in orchid flowers re-interpreted using the Musk Orchid as a model.
authors: ['Rudall PJ', 'Perl CD', 'Bateman RM']
source: PeerJ. 2013 Feb 12;1:e26. doi: 10.7717/peerj.26. Print 2013.

title: Accessing local knowledge to identify where species of conservation concern occur in a tropical forest landscape.
authors: ['Padmanaba M', 'Sheil D', 'Basuki I', 'Liswanti N']
source: Environ Manage. 2013 Aug;52(2):348-59. doi: 10.1007/s00267-013-0051-7. Epub 2013 May 1.

title: Spatial patterns of photosynthesis in thin- and thick-leaved epiphytic orchids: unravelling C3-CAM plasticity in an organ-compartmented way.
authors: ['Rodrigues MA', 'Matiz A', 'Cruz AB', 'Matsumura AT', 'Takahashi CA', 'Hamachi L', 'Felix LM', 'Pereira PN', 'Latansio-Aidar SR', 'Aidar MP', 'Demarco D', 'Freschi L', 'Mercier H', 'Kerbauy GB']
source: Ann Bot. 2013 Jul;112(1):17-29. doi: 10.1093/aob/mct090. Epub 2013 Apr 25.

title: Transcriptome analysis of Cymbidium sinense and its application to the identification of genes associated with floral development.
authors: ['Zhang J', 'Wu K', 'Zeng S', 'Teixeira da Silva JA', 'Zhao X', 'Tian CE', 'Xia H', 'Duan J']
source: BMC Genomics. 2013 Apr 24;14:279. doi: 10.1186/1471-2164-14-279.

title: Orchid fleck virus structural proteins N and P form intranuclear viroplasm-like structures in the absence of viral infection.
authors: ['Kondo H', 'Chiba S', 'Andika IB', 'Maruyama K', 'Tamada T', 'Suzuki N']
source: J Virol. 2013 Jul;87(13):7423-34. doi: 10.1128/JVI.00270-13. Epub 2013 Apr 24.

title: Scale-up of a comprehensive harm reduction programme for people injecting opioids: lessons from north-eastern India.
authors: ['Lalmuanpuii M', 'Biangtung L', 'Mishra RK', 'Reeve MJ', 'Tzudier S', 'Singh AL', 'Sinate R', 'Sgaier SK']
source: Bull World Health Organ. 2013 Apr 1;91(4):306-12. doi: 10.2471/BLT.12.108274. Epub 2013 Feb 20.

title: Complete chloroplast genome of the genus Cymbidium: lights into the species identification, phylogenetic implications and population genetic analyses.
authors: ['Yang JB', 'Tang M', 'Li HT', 'Zhang ZR', 'Li DZ']
source: BMC Evol Biol. 2013 Apr 18;13:84. doi: 10.1186/1471-2148-13-84.

title: A novel aphrodisiac compound from an orchid that activates nitric oxide synthases.
authors: ['Subramoniam A', 'Gangaprasad A', 'Sureshkumar PK', 'Radhika J', 'Arun KB']
source: Int J Impot Res. 2013 Nov-Dec;25(6):212-6. doi: 10.1038/ijir.2013.18. Epub 2013 Apr 18.

title: A new orchid genus, Danxiaorchis, and phylogenetic analysis of the tribe Calypsoeae.
authors: ['Zhai JW', 'Zhang GQ', 'Chen LJ', 'Xiao XJ', 'Liu KW', 'Tsai WC', 'Hsiao YY', 'Tian HZ', 'Zhu JQ', 'Wang MN', 'Wang FG', 'Xing FW', 'Liu ZJ']
source: PLoS One. 2013 Apr 4;8(4):e60371. doi: 10.1371/journal.pone.0060371. Print 2013.

title: Detection of ancestry informative HLA alleles confirms the admixed origins of Japanese population.
authors: ['Nakaoka H', 'Mitsunaga S', 'Hosomichi K', 'Shyh-Yuh L', 'Sawamoto T', 'Fujiwara T', 'Tsutsui N', 'Suematsu K', 'Shinagawa A', 'Inoko H', 'Inoue I']
source: PLoS One. 2013;8(4):e60793. doi: 10.1371/journal.pone.0060793. Epub 2013 Apr 5.

title: A new molecular phylogeny and a new genus, Pendulorchis, of the Aerides-Vanda alliance (Orchidaceae: Epidendroideae).
authors: ['Zhang GQ', 'Liu KW', 'Chen LJ', 'Xiao XJ', 'Zhai JW', 'Li LQ', 'Cai J', 'Hsiao YY', 'Rao WH', 'Huang J', 'Ma XY', 'Chung SW', 'Huang LQ', 'Tsai WC', 'Liu ZJ']
source: PLoS One. 2013;8(4):e60097. doi: 10.1371/journal.pone.0060097. Epub 2013 Apr 5.

title: Catalog of Erycina pusilla miRNA and categorization of reproductive phase-related miRNAs and their target gene families.
authors: ['Lin CS', 'Chen JJ', 'Huang YT', 'Hsu CT', 'Lu HC', 'Chou ML', 'Chen LC', 'Ou CI', 'Liao DC', 'Yeh YY', 'Chang SB', 'Shen SC', 'Wu FH', 'Shih MC', 'Chan MT']
source: Plant Mol Biol. 2013 May;82(1-2):193-204. doi: 10.1007/s11103-013-0055-y. Epub 2013 Apr 11.

title: The rare terrestrial orchid Nervilia nipponica consistently associates with a single group of novel mycobionts.
authors: ['Nomura N', 'Ogura-Tsujita Y', 'Gale SW', 'Maeda A', 'Umata H', 'Hosaka K', 'Yukawa T']
source: J Plant Res. 2013 Sep;126(5):613-23. doi: 10.1007/s10265-013-0552-8. Epub 2013 Apr 6.

title: Compatible fungi, suitable medium, and appropriate developmental stage essential for stable association of Dendrobium chrysanthum.
authors: ['Hajong S', 'Kumaria S', 'Tandon P']
source: J Basic Microbiol. 2013 Dec;53(12):1025-33. doi: 10.1002/jobm.201200411. Epub 2013 Apr 2.

title: The host bias of three epiphytic Aeridinae orchid species is reflected, but not explained, by mycorrhizal fungal associations.
authors: ['Gowland KM', 'van der Merwe MM', 'Linde CC', 'Clements MA', 'Nicotra AB']
source: Am J Bot. 2013 Apr;100(4):764-77. doi: 10.3732/ajb.1200411. Epub 2013 Apr 1.

title: Tubastatin, a selective histone deacetylase 6 inhibitor shows anti-inflammatory and anti-rheumatic effects.
authors: ['Vishwakarma S', 'Iyer LR', 'Muley M', 'Singh PK', 'Shastry A', 'Saxena A', 'Kulathingal J', 'Vijaykanth G', 'Raghul J', 'Rajesh N', 'Rathinasamy S', 'Kachhadia V', 'Kilambi N', 'Rajgopal S', 'Balasubramanian G', 'Narayanan S']
source: Int Immunopharmacol. 2013 May;16(1):72-8. doi: 10.1016/j.intimp.2013.03.016. Epub 2013 Mar 27.

title: Microsatellite markers in the western prairie fringed orchid, Platanthera praeclara (Orchidaceae).
authors: ['Ross AA', 'Aldrich-Wolfe L', 'Lance S', 'Glenn T', 'Travers SE']
source: Appl Plant Sci. 2013 Mar 22;1(4). pii: apps.1200413. doi: 10.3732/apps.1200413. eCollection 2013 Apr.

title: Discovery of adamantane based highly potent HDAC inhibitors.
authors: ['Gopalan B', 'Ponpandian T', 'Kachhadia V', 'Bharathimohan K', 'Vignesh R', 'Sivasudar V', 'Narayanan S', 'Mandar B', 'Praveen R', 'Saranya N', 'Rajagopal S', 'Rajagopal S']
source: Bioorg Med Chem Lett. 2013 May 1;23(9):2532-7. doi: 10.1016/j.bmcl.2013.03.002. Epub 2013 Mar 14.

title: Mycorrhizas alter nitrogen acquisition by the terrestrial orchid Cymbidium goeringii.
authors: ['Wu J', 'Ma H', 'Xu X', 'Qiao N', 'Guo S', 'Liu F', 'Zhang D', 'Zhou L']
source: Ann Bot. 2013 Jun;111(6):1181-7. doi: 10.1093/aob/mct062. Epub 2013 Mar 26.

title: Variation in nutrient-acquisition patterns by mycorrhizal fungi of rare and common orchids explains diversification in a global biodiversity hotspot.
authors: ['Nurfadilah S', 'Swarts ND', 'Dixon KW', 'Lambers H', 'Merritt DJ']
source: Ann Bot. 2013 Jun;111(6):1233-41. doi: 10.1093/aob/mct064. Epub 2013 Mar 26.

title: Bioanalytical method development, validation and quantification of dorsomorphin in rat plasma by LC-MS/MS.
authors: ['Karthikeyan K', 'Mahat MY', 'Chandrasekaran S', 'Gopal K', 'Franklin PX', 'Sivakumar BJ', 'Singh G', 'Narayanan S', 'Gopalan B', 'Khan AA']
source: Biomed Chromatogr. 2013 Aug;27(8):1018-26. doi: 10.1002/bmc.2899. Epub 2013 Mar 21.

title: Cryopreservation of orchid mycorrhizal fungi: a tool for the conservation of endangered species.
authors: ['Ercole E', 'Rodda M', 'Molinatti M', 'Voyron S', 'Perotto S', 'Girlanda M']
source: J Microbiol Methods. 2013 May;93(2):134-7. doi: 10.1016/j.mimet.2013.03.003. Epub 2013 Mar 18.

title: Climate warming alters effects of management on population viability of threatened species: results from a 30-year experimental study on a rare orchid.
authors: ['Sletvold N', 'Dahlgren JP', 'Oien DI', 'Moen A', 'Ehrlen J']
source: Glob Chang Biol. 2013 Sep;19(9):2729-38. doi: 10.1111/gcb.12167. Epub 2013 Jul 14.

title: [Molecular characterization of a mitogen-activated protein kinase gene DoMPK1 in Dendrobium officinale].
authors: ['Zhang G', 'Zhao MM', 'Song C', 'Zhang DW', 'Li B', 'Guo SX']
source: Yao Xue Xue Bao. 2012 Dec;47(12):1703-9.

title: Contributions of covariance: decomposing the components of stochastic population growth in Cypripedium calceolus.
authors: ['Davison R', 'Nicole F', 'Jacquemyn H', 'Tuljapurkar S']
source: Am Nat. 2013 Mar;181(3):410-20. doi: 10.1086/669155. Epub 2013 Jan 18.

title: Phylogenetic and microsatellite markers for Tulasnella (Tulasnellaceae) mycorrhizal fungi associated with Australian orchids.
authors: ['Ruibal MP', 'Peakall R', 'Smith LM', 'Linde CC']
source: Appl Plant Sci. 2013 Mar 5;1(3). pii: apps.1200394. doi: 10.3732/apps.1200394. eCollection 2013 Mar.

title: Ascertaining the role of Taiwan as a source for the Austronesian expansion.
authors: ['Mirabal S', 'Cadenas AM', 'Garcia-Bertrand R', 'Herrera RJ']
source: Am J Phys Anthropol. 2013 Apr;150(4):551-64. doi: 10.1002/ajpa.22226. Epub 2013 Feb 26.

title: Acquisition of species-specific perfume blends: influence of habitat-dependent compound availability on odour choices of male orchid bees (Euglossa spp.).
authors: ['Pokorny T', 'Hannibal M', 'Quezada-Euan JJ', 'Hedenstrom E', 'Sjoberg N', 'Bang J', 'Eltz T']
source: Oecologia. 2013 Jun;172(2):417-25. doi: 10.1007/s00442-013-2620-0. Epub 2013 Feb 27.

title: Fertilizing ability of cryopreserved pollinia of Luisia macrantha, an endemic orchid of Western Ghats.
authors: ['Ajeeshkumar S', 'Decruse SW']
source: Cryo Letters. 2013 Jan-Feb;34(1):20-9.

title: A narrowly endemic photosynthetic orchid is non-specific in its mycorrhizal associations.
authors: ['Pandey M', 'Sharma J', 'Taylor DL', 'Yadon VL']
source: Mol Ecol. 2013 Apr;22(8):2341-54. doi: 10.1111/mec.12249. Epub 2013 Feb 21.

title: Global transcriptome analysis and identification of a CONSTANS-like gene family in the orchid Erycina pusilla.
authors: ['Chou ML', 'Shih MC', 'Chan MT', 'Liao SY', 'Hsu CT', 'Haung YT', 'Chen JJ', 'Liao DC', 'Wu FH', 'Lin CS']
source: Planta. 2013 Jun;237(6):1425-41. doi: 10.1007/s00425-013-1850-z. Epub 2013 Feb 16.

title: Overexpression of DOSOC1, an ortholog of Arabidopsis SOC1, promotes flowering in the orchid Dendrobium Chao Parya Smile.
authors: ['Ding L', 'Wang Y', 'Yu H']
source: Plant Cell Physiol. 2013 Apr;54(4):595-608. doi: 10.1093/pcp/pct026. Epub 2013 Feb 8.

title: SPAR methods revealed high genetic diversity within populations and high gene flow of Vanda coerulea Griff ex Lindl (Blue Vanda), an endangered orchid species.
authors: ['Manners V', 'Kumaria S', 'Tandon P']
source: Gene. 2013 Apr 25;519(1):91-7. doi: 10.1016/j.gene.2013.01.037. Epub 2013 Feb 8.

title: Oriental orchid (Cymbidium floribundum) attracts the Japanese honeybee (Apis cerana japonica) with a mixture of 3-hydroxyoctanoic acid and 10-hydroxy- (E)-2-decenoic acid.
authors: ['Sugahara M', 'Izutsu K', 'Nishimura Y', 'Sakamoto F']
source: Zoolog Sci. 2013 Feb;30(2):99-104. doi: 10.2108/zsj.30.99.

title: [Cloning and expression analysis of a calcium-dependent protein kinase gene in Dendrobium officinale in response to mycorrhizal fungal infection].
authors: ['Zhang G', 'Zhao MM', 'Li B', 'Song C', 'Zhang DW', 'Guo SX']
source: Yao Xue Xue Bao. 2012 Nov;47(11):1548-54.

title: Sperm elution: an improved two phase recovery method for sexual assault samples.
authors: ['Hulme P', 'Lewis J', 'Davidson G']
source: Sci Justice. 2013 Mar;53(1):28-33. doi: 10.1016/j.scijus.2012.05.003. Epub 2012 May 28.

title: Marital satisfaction and physical health: evidence for an orchid effect.
authors: ['South SC', 'Krueger RF']
source: Psychol Sci. 2013 Mar 1;24(3):373-8. doi: 10.1177/0956797612453116. Epub 2013 Jan 28.

title: Optimizing virus-induced gene silencing efficiency with Cymbidium mosaic virus in Phalaenopsis flower.
authors: ['Hsieh MH', 'Lu HC', 'Pan ZJ', 'Yeh HH', 'Wang SS', 'Chen WH', 'Chen HH']
source: Plant Sci. 2013 Mar;201-202:25-41. doi: 10.1016/j.plantsci.2012.11.003. Epub 2012 Nov 26.

title: Diversity and evolutionary patterns of bacterial gut associates of corbiculate bees.
authors: ['Koch H', 'Abrol DP', 'Li J', 'Schmid-Hempel P']
source: Mol Ecol. 2013 Apr;22(7):2028-44. doi: 10.1111/mec.12209. Epub 2013 Jan 24.

title: Fungal host specificity is not a bottleneck for the germination of Pyroleae species (Ericaceae) in a Bavarian forest.
authors: ['Hynson NA', 'Weiss M', 'Preiss K', 'Gebauer G', 'Treseder KK']
source: Mol Ecol. 2013 Mar;22(5):1473-81. doi: 10.1111/mec.12180. Epub 2013 Jan 24.

title: Morphological, ecological and genetic aspects associated with endemism in the Fly Orchid group.
authors: ['Triponez Y', 'Arrigo N', 'Pellissier L', 'Schatz B', 'Alvarez N']
source: Mol Ecol. 2013 Mar;22(5):1431-46. doi: 10.1111/mec.12169. Epub 2013 Jan 21.

title: Australian orchids and the doctors they commemorate.
authors: ['Pearn JH']
source: Med J Aust. 2013 Jan 21;198(1):52-4.

title: Orchidstra: an integrated orchid functional genomics database.
authors: ['Su CL', 'Chao YT', 'Yen SH', 'Chen CY', 'Chen WC', 'Chang YC', 'Shih MC']
source: Plant Cell Physiol. 2013 Feb;54(2):e11. doi: 10.1093/pcp/pct004. Epub 2013 Jan 16.

title: First Report of Sclerotium Rot on Cymbidium Orchids Caused by Sclerotium rolfsii in Korea.
authors: ['Han KS', 'Lee SC', 'Lee JS', 'Soh JW', 'Kim S']
source: Mycobiology. 2012 Dec;40(4):263-4. doi: 10.5941/MYCO.2012.40.4.263. Epub 2012 Dec 26.

title: Genetic linkage map of EST-SSR and SRAP markers in the endangered Chinese endemic herb Dendrobium (Orchidaceae).
authors: ['Lu JJ', 'Wang S', 'Zhao HY', 'Liu JJ', 'Wang HZ']
source: Genet Mol Res. 2012 Dec 21;11(4):4654-67. doi: 10.4238/2012.December.21.1.

title: OrchidBase 2.0: comprehensive collection of Orchidaceae floral transcriptomes.
authors: ['Tsai WC', 'Fu CH', 'Hsiao YY', 'Huang YM', 'Chen LJ', 'Wang M', 'Liu ZJ', 'Chen HH']
source: Plant Cell Physiol. 2013 Feb;54(2):e7. doi: 10.1093/pcp/pcs187. Epub 2013 Jan 10.

title: Adding perches for cross-pollination ensures the reproduction of a self-incompatible orchid.
authors: ['Liu ZJ', 'Chen LJ', 'Liu KW', 'Li LQ', 'Rao WH', 'Zhang YT', 'Tang GD', 'Huang LQ']
source: PLoS One. 2013;8(1):e53695. doi: 10.1371/journal.pone.0053695. Epub 2013 Jan 7.

title: Aerial roots of epiphytic orchids: the velamen radicum and its role in water and nutrient uptake.
authors: ['Zotz G', 'Winkler U']
source: Oecologia. 2013 Mar;171(3):733-41. doi: 10.1007/s00442-012-2575-6. Epub 2013 Jan 6.

title: The OitaAG and OitaSTK genes of the orchid Orchis italica: a comparative analysis with other C- and D-class MADS-box genes.
authors: ['Salemme M', 'Sica M', 'Gaudio L', 'Aceto S']
source: Mol Biol Rep. 2013 May;40(5):3523-35. doi: 10.1007/s11033-012-2426-x. Epub 2013 Jan 1.

title: Mycorrhizal preference promotes habitat invasion by a native Australian orchid: Microtis media.
authors: ['De Long JR', 'Swarts ND', 'Dixon KW', 'Egerton-Warburton LM']
source: Ann Bot. 2013 Mar;111(3):409-18. doi: 10.1093/aob/mcs294. Epub 2012 Dec 28.

title: [Plant rhabdoviruses with bipartite genomes].
authors: ['Kondo H']
source: Uirusu. 2013;63(2):143-54.

title: Functional characterization of Candida albicans Hos2 histone deacetylase.
authors: ['Karthikeyan G', 'Paul-Satyaseela M', 'Dhatchana Moorthy N', 'Gopalaswamy R', 'Narayanan S']
source: F1000Res. 2013 Nov 11;2:238. doi: 10.12688/f1000research.2-238.v3. eCollection 2013.

title: Eufriesea zhangi sp. n. (Hymenoptera: Apidae: Euglossina), a new orchid bee from Brazil revealed by molecular and morphological characters.
authors: ['Nemesio A', 'Junior JE', 'Santos FR']
source: Zootaxa. 2013 Feb 4;3609:568-82. doi: 10.11646/zootaxa.3609.6.2.

title: Specificity and preference of mycorrhizal associations in two species of the genus Dendrobium (Orchidaceae).
authors: ['Xing X', 'Ma X', 'Deng Z', 'Chen J', 'Wu F', 'Guo S']
source: Mycorrhiza. 2013 May;23(4):317-24. doi: 10.1007/s00572-012-0473-8. Epub 2012 Dec 28.

title: Transcriptomic analysis of floral organs from Phalaenopsis orchid by using oligonucleotide microarray.
authors: ['Hsiao YY', 'Huang TH', 'Fu CH', 'Huang SC', 'Chen YJ', 'Huang YM', 'Chen WH', 'Tsai WC', 'Chen HH']
source: Gene. 2013 Apr 10;518(1):91-100. doi: 10.1016/j.gene.2012.11.069. Epub 2012 Dec 20.

title: mRNA profiling using a minimum of five mRNA markers per body fluid and a novel scoring method for body fluid identification.
authors: ['Roeder AD', 'Haas C']
source: Int J Legal Med. 2013 Jul;127(4):707-21. doi: 10.1007/s00414-012-0794-3. Epub 2012 Dec 20.

title: Monophyly or paraphyly--the taxonomy of Holcoglossum (Aeridinae: Orchidaceae).
authors: ['Xiang X', 'Li D', 'Jin X', 'Hu H', 'Zhou H', 'Jin W', 'Lai Y']
source: PLoS One. 2012;7(12):e52050. doi: 10.1371/journal.pone.0052050. Epub 2012 Dec 14.

title: A comparative study of vitrification and encapsulation-vitrification for cryopreservation of protocorms of Cymbidium eburneum L., a threatened and vulnerable orchid of India.
authors: ['Gogoi K', 'Kumaria S', 'Tandon P']
source: Cryo Letters. 2012 Nov-Dec;33(6):443-52.

title: Understanding the association between injecting and sexual risk behaviors of injecting drug users in Manipur and Nagaland, India.
authors: ['Suohu K', 'Humtsoe C', 'Saggurti N', 'Sabarwal S', 'Mahapatra B', 'Kermode M']
source: Harm Reduct J. 2012 Dec 18;9:40. doi: 10.1186/1477-7517-9-40.

title: A new antibacterial phenanthrenequinone from Dendrobium sinense.
authors: ['Chen XJ', 'Mei WL', 'Zuo WJ', 'Zeng YB', 'Guo ZK', 'Song XQ', 'Dai HF']
source: J Asian Nat Prod Res. 2013;15(1):67-70. doi: 10.1080/10286020.2012.740473. Epub 2012 Dec 11.

title: The Doctrine of Signatures, Materia Medica of Orchids, and the Contributions of Doctor - Orchidologists.
authors: ['Pearn J']
source: Vesalius. 2012 Dec;18(2):99-106.

title: Reference-free comparative genomics of 174 chloroplasts.
authors: ['Kua CS', 'Ruan J', 'Harting J', 'Ye CX', 'Helmus MR', 'Yu J', 'Cannon CH']
source: PLoS One. 2012;7(11):e48995. doi: 10.1371/journal.pone.0048995. Epub 2012 Nov 20.

title: Multiple shoot induction from axillary bud cultures of the medicinal orchid, Dendrobium longicornu.
authors: ['Dohling S', 'Kumaria S', 'Tandon P']
source: AoB Plants. 2012;2012:pls032. doi: 10.1093/aobpla/pls032. Epub 2012 Nov 5.

title: Germination failure is not a critical stage of reproductive isolation between three congeneric orchid species.
authors: ['De Hert K', 'Honnay O', 'Jacquemyn H']
source: Am J Bot. 2012 Nov;99(11):1884-90. doi: 10.3732/ajb.1200381. Epub 2012 Nov 6.

title: Three new cryptic species of Euglossa from Brazil (Hymenoptera, Apidae).
authors: ['Nemesio A', 'Engel MS']
source: Zookeys. 2012;(222):47-68. doi: 10.3897/zookeys.222.3382. Epub 2012 Sep 21.

title: Two new species of Euglossa from South America, with notes on their taxonomic affinities (Hymenoptera, Apidae).
authors: ['Hinojosa-Diaz IA', 'Nemesio A', 'Engel MS']
source: Zookeys. 2012;(221):63-79. doi: 10.3897/zookeys.221.3659. Epub 2012 Sep 13.

title: Genetic variation and structure within 3 endangered Calanthe species (Orchidaceae) from Korea: inference of population-establishment history and implications for conservation.
authors: ['Chung MY', 'Lopez-Pujol J', 'Maki M', 'Moon MO', 'Hyun JO', 'Chung MG']
source: J Hered. 2013 Mar;104(2):248-62. doi: 10.1093/jhered/ess088. Epub 2012 Nov 1.

title: Briacavatolides D-F, new briaranes from the Taiwanese octocoral Briareum excavatum.
authors: ['Wang SK', 'Yeh TT', 'Duh CY']
source: Mar Drugs. 2012 Sep;10(9):2103-10. doi: 10.3390/md10092103. Epub 2012 Sep 24.

title: Observational Research in Childhood Infectious Diseases (ORChID): a dynamic birth cohort study.
authors: ['Lambert SB', 'Ware RS', 'Cook AL', 'Maguire FA', 'Whiley DM', 'Bialasiewicz S', 'Mackay IM', 'Wang D', 'Sloots TP', 'Nissen MD', 'Grimwood K']
source: BMJ Open. 2012 Oct 31;2(6). pii: e002134. doi: 10.1136/bmjopen-2012-002134. Print 2012.

title: Microsatellite primers for the neotropical epiphyte Epidendrum firmum (Orchidaceae).
authors: ['Kartzinel TR', 'Trapnell DW', 'Glenn TC']
source: Am J Bot. 2012 Nov;99(11):e450-2. doi: 10.3732/ajb.1200232. Epub 2012 Oct 31.

title: The production of a key floral volatile is dependent on UV light in a sexually deceptive orchid.
authors: ['Falara V', 'Amarasinghe R', 'Poldy J', 'Pichersky E', 'Barrow RA', 'Peakall R']
source: Ann Bot. 2013 Jan;111(1):21-30. doi: 10.1093/aob/mcs228. Epub 2012 Oct 22.

title: Exotic and indigenous viruses infect wild populations and captive collections of temperate terrestrial orchids (Diuris species) in Australia.
authors: ['Wylie SJ', 'Li H', 'Dixon KW', 'Richards H', 'Jones MG']
source: Virus Res. 2013 Jan;171(1):22-32. doi: 10.1016/j.virusres.2012.10.003. Epub 2012 Oct 23.

title: Orchid fleck virus: an unclassified bipartite, negative-sense RNA plant virus.
authors: ['Peng de W', 'Zheng GH', 'Zheng ZZ', 'Tong QX', 'Ming YL']
source: Arch Virol. 2013 Feb;158(2):313-23. doi: 10.1007/s00705-012-1506-5. Epub 2012 Oct 16.

title: Untangling above- and belowground mycorrhizal fungal networks in tropical orchids.
authors: ['Leake JR', 'Cameron DD']
source: Mol Ecol. 2012 Oct;21(20):4921-4. doi: 10.1111/j.1365-294X.2012.05718.x.

title: Pre-adaptations and the evolution of pollination by sexual deception: Cope's rule of specialization revisited.
authors: ['Vereecken NJ', 'Wilson CA', 'Hotling S', 'Schulz S', 'Banketov SA', 'Mardulyn P']
source: Proc Biol Sci. 2012 Dec 7;279(1748):4786-94. doi: 10.1098/rspb.2012.1804. Epub 2012 Oct 10.

title: The mirror crack'd: both pigment and structure contribute to the glossy blue appearance of the mirror orchid, Ophrys speculum.
authors: ['Vignolini S', 'Davey MP', 'Bateman RM', 'Rudall PJ', 'Moyroud E', 'Tratt J', 'Malmgren S', 'Steiner U', 'Glover BJ']
source: New Phytol. 2012 Dec;196(4):1038-47. doi: 10.1111/j.1469-8137.2012.04356.x. Epub 2012 Oct 9.

The output for this looks like:

title: Sex pheromone mimicry in the early spider orchid (ophrys sphegodes):
patterns of hydrocarbons as the key mechanism for pollination by sexual
deception [In Process Citation]
authors: ['Schiestl FP', 'Ayasse M', 'Paulus HF', 'Lofstedt C', 'Hansson BS',
'Ibarra F', 'Francke W']
source: J Comp Physiol [A] 2000 Jun;186(6):567-74

Especially interesting to note is the list of authors, which is returned as a standard Python list. This makes it easy to manipulate and search using standard Python tools. For instance, we could loop through a whole bunch of entries searching for a particular author with code like the following:

In [60]:
search_author = "Waits T"
In [61]:
for record in records:
    if not "AU" in record:
        continue
    if search_author in record["AU"]:
        print("Author %s found: %s" % (search_author, record["SO"]))

Hopefully this section gave you an idea of the power and flexibility of the Entrez and Medline interfaces and how they can be used together.

Searching, downloading, and parsing Entrez Nucleotide records

Here we’ll show a simple example of performing a remote Entrez query. In section [sec:orchids] of the parsing examples, we talked about using NCBI’s Entrez website to search the NCBI nucleotide databases for info on Cypripedioideae, our friends the lady slipper orchids. Now, we’ll look at how to automate that process using a Python script. In this example, we’ll just show how to connect, get the results, and parse them, with the Entrez module doing all of the work.

First, we use EGQuery to find out the number of results we will get before actually downloading them. EGQuery will tell us how many search results were found in each of the databases, but for this example we are only interested in nucleotides:

In [62]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.egquery(term="Cypripedioideae")
record = Entrez.read(handle)
for row in record["eGQueryResult"]:
    if row["DbName"]=="nuccore":
        print(row["Count"])
4247

So, we expect to find 814 Entrez Nucleotide records (this is the number I obtained in 2008; it is likely to increase in the future). If you find some ridiculously high number of hits, you may want to reconsider if you really want to download all of them, which is our next step:

In [63]:
from Bio import Entrez
handle = Entrez.esearch(db="nucleotide", term="Cypripedioideae", retmax=814)
record = Entrez.read(handle)

Here, record is a Python dictionary containing the search results and some auxiliary information. Just for information, let’s look at what is stored in this dictionary:

In [64]:
print(record.keys())
dict_keys(['TranslationStack', 'IdList', 'TranslationSet', 'QueryTranslation', 'Count', 'RetStart', 'RetMax'])

First, let’s check how many results were found:

In [65]:
print(record["Count"])
4247

which is the number we expected. The 814 results are stored in record['IdList']:

In [66]:
len(record["IdList"])
Out[66]:
814

Let’s look at the first five results:

In [67]:
record["IdList"][:5]
Out[67]:
['874509867', '874509089', '844174433', '937957673', '694174838']

[sec:entrez-batched-efetch] We can download these records using efetch. While you could download these records one by one, to reduce the load on NCBI’s servers, it is better to fetch a bunch of records at the same time, shown below. However, in this situation you should ideally be using the history feature described later in Section History and WebEnv.

In [68]:
idlist = ",".join(record["IdList"][:5])
print(idlist)
874509867,874509089,844174433,937957673,694174838
In [69]:
handle = Entrez.efetch(db="nucleotide", id=idlist, retmode="xml")
records = Entrez.read(handle)
len(records)
Out[69]:
5

Each of these records corresponds to one GenBank record.

In [70]:
print(records[0].keys())
dict_keys(['GBSeq_division', 'GBSeq_moltype', 'GBSeq_definition', 'GBSeq_topology', 'GBSeq_locus', 'GBSeq_strandedness', 'GBSeq_source', 'GBSeq_taxonomy', 'GBSeq_create-date', 'GBSeq_accession-version', 'GBSeq_references', 'GBSeq_sequence', 'GBSeq_other-seqids', 'GBSeq_primary-accession', 'GBSeq_length', 'GBSeq_update-date', 'GBSeq_feature-table', 'GBSeq_organism'])
In [71]:
print(records[0]["GBSeq_primary-accession"])
KP644081
In [72]:
print(records[0]["GBSeq_other-seqids"])
['gnl|uoguelph|SCBI449-14.rbcLa', 'gb|KP644081.1|', 'gi|874509867']
In [73]:
print(records[0]["GBSeq_definition"])
Cypripedium calceolus voucher SNP_13_0359 ribulose-1,5-bisphosphate carboxylase/oxygenase large subunit (rbcL) gene, partial cds; chloroplast
In [74]:
print(records[0]["GBSeq_organism"])
Cypripedium calceolus

You could use this to quickly set up searches – but for heavy usage, see Section History and WebEnv.

Searching, downloading, and parsing GenBank records

The GenBank record format is a very popular method of holding information about sequences, sequence features, and other associated sequence information. The format is a good way to get information from the NCBI databases at http://www.ncbi.nlm.nih.gov/.

In this example we’ll show how to query the NCBI databases,to retrieve the records from the query, and then parse them using Bio.SeqIO - something touched on in Section [sec:SeqIO_GenBank_Online]. For simplicity, this example does not take advantage of the WebEnv history feature – see Section History and WebEnv for this.

First, we want to make a query and find out the ids of the records to retrieve. Here we’ll do a quick search for one of our favorite organisms, Opuntia (prickly-pear cacti). We can do quick search and get back the GIs (GenBank identifiers) for all of the corresponding records. First we check how many records there are:

In [75]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.egquery(term="Opuntia AND rpl16")
record = Entrez.read(handle)
for row in record["eGQueryResult"]:
    if row["DbName"]=="nuccore":
        print(row["Count"])
26

Now we download the list of GenBank identifiers:

In [76]:
handle = Entrez.esearch(db="nuccore", term="Opuntia AND rpl16")
record = Entrez.read(handle)
gi_list = record["IdList"]
gi_list
Out[76]:
['377581039', '330887241', '330887240', '330887239', '330887238', '330887237', '330887236', '330887235', '330887233', '330887232', '330887231', '330887228', '330887227', '330887226', '330887225', '330887224', '330887223', '57240072', '57240071', '6273287']

Now we use these GIs to download the GenBank records - note that with older versions of Biopython you had to supply a comma separated list of GI numbers to Entrez, as of Biopython 1.59 you can pass a list and this is converted for you:

In [77]:
gi_str = ",".join(gi_list)
handle = Entrez.efetch(db="nuccore", id=gi_str, rettype="gb", retmode="text")

If you want to look at the raw GenBank files, you can read from this handle and print out the result:

In [78]:
text = handle.read()
print(text)
LOCUS       HQ621368                 399 bp    DNA     linear   PLN 26-FEB-2012
DEFINITION  Opuntia decumbens voucher Martinez & Eggli 146a (ZSS) ribosomal
            protein L16 (rpl16) gene, partial cds; chloroplast.
ACCESSION   HQ621368
VERSION     HQ621368.1  GI:377581039
KEYWORDS    .
SOURCE      chloroplast Opuntia decumbens
  ORGANISM  Opuntia decumbens
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 399)
  AUTHORS   Arakaki,M., Christin,P.A., Nyffeler,R., Lendel,A., Eggli,U.,
            Ogburn,R.M., Spriggs,E., Moore,M.J. and Edwards,E.J.
  TITLE     Contemporaneous and recent radiations of the world's major
            succulent plant lineages
  JOURNAL   Proc. Natl. Acad. Sci. U.S.A. 108 (20), 8379-8384 (2011)
   PUBMED   21536881
REFERENCE   2  (bases 1 to 399)
  AUTHORS   Arakaki,M., Christin,P.-A., Nyffeler,R., Eggli,U., Ogburn,R.M.,
            Spriggs,E., Moore,M.J. and Edwards,E.J.
  TITLE     Direct Submission
  JOURNAL   Submitted (15-NOV-2010) Department of Ecology and Evolutionary
            Biology, Brown University, 80 Waterman St., Providence, RI 02912,
            USA
COMMENT     ##Assembly-Data-START##
            Assembly Method       :: MIRA V3rc4; Geneious v. 4.8
            Sequencing Technology :: 454
            ##Assembly-Data-END##
FEATURES             Location/Qualifiers
     source          1..399
                     /organism="Opuntia decumbens"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /specimen_voucher="Martinez & Eggli 146a (ZSS)"
                     /db_xref="taxon:867482"
                     /tissue_type="stem"
                     /note="authority: Opuntia decumbens Salm-Dyck"
     gene            <1..>399
                     /gene="rpl16"
     CDS             <1..>399
                     /gene="rpl16"
                     /codon_start=1
                     /transl_table=11
                     /product="ribosomal protein L16"
                     /protein_id="AFB70658.1"
                     /db_xref="GI:377581040"
                     /translation="NPKRTRFCKQHRGRMKGISYRGNRICFGRYALQALEPAWITSRQ
                     IEAGRRAMTRNARRGGKIWVRIFPDKPVTVKSAESRMGSGKGSHLYWVVVVKPGRILY
                     EISGVSENIARRAISIAASKMPVRTQFIISG"
ORIGIN
        1 aaccccaaaa gaaccagatt ctgtaaacaa catagaggaa gaatgaaggg aatatcttat
       61 cgggggaatc gtatttgttt cggaagatat gctcttcagg cacttgagcc tgcttggatc
      121 acgtctagac aaatagaagc aggtcggcga gcaatgacgc gaaatgcacg ccgcggtgga
      181 aaaatatggg tacgtatatt tccagacaaa ccagttacag taaaatctgc ggaaagccgt
      241 atgggttcgg ggaaaggatc ccacctatat tgggtagttg ttgtcaaacc cggtcgaata
      301 ctttatgaaa taagcggagt atcagaaaat atagcccgaa gggctatctc gatagcggca
      361 tctaaaatgc ctgtacgaac tcaattcatt atttcagga
//

LOCUS       HM041482                1197 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Cylindropuntia tunicata ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041482
VERSION     HM041482.1  GI:330887241
KEYWORDS    .
SOURCE      chloroplast Cylindropuntia tunicata
  ORGANISM  Cylindropuntia tunicata
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Cylindropuntia.
REFERENCE   1  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1197
                     /organism="Cylindropuntia tunicata"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:766221"
     gene            <1..>1197
                     /gene="rpl16"
     misc_feature    <1094..>1197
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gtgatatacg aaacagtaag agcccatagt atgaagtatg aactaataac tatagaacta
       61 ataaccaact catcgcatca cattatctgg atccaaagaa gcagtcaaga taggatattt
      121 tggtcctatc attgcagcaa ctgaattttt tttttcataa acaagaaatc gaatgagttg
      181 tcaagcaaaa gaaaaaaaaa aaaagaaaaa tatacnttaa aggaggggga tgcggataaa
      241 tggaaaggcg aaagaaagaa aaaaatgaat ctaaatgata tacgattcca ctatgtaagg
      301 tctttgaatc atatcataaa agacaatgta ataaagcatg aatacagatt cacacataat
      361 tatctgatat gaatctattc atagaaaaaa gaaaaaagta agagcctccg gccaataaag
      421 actaagaggg gttggctcaa aaacaaagtt cattaagagc tcccattgta gaattcagac
      481 ctaatcatta atcaagaagc gatgggaacg atgtaatcca tgaatacaga agattcaatt
      541 gaaaaaagaa tcctaatgat tcattgggga ggatggcgga acgaaccaga gaccaattca
      601 tctattctga aaagtgataa actaatccta taaaactaaa atagatattg aaagagtaaa
      661 tattcgcccg cgaaaattcc ttttttatta aattgctcat attttatttt agcaatgcaa
      721 tctaataaaa tatatctata caaaaaaaca tagacaaact atatatataa tatttcaaat
      781 tcccttatat atccaaatat aaaaatatct aataaattag atgaatatca aagaatctat
      841 tgatttagtg tattattaaa tgtatatctt aattcaatat tattattcta ttcattttta
      901 ttcattttca aatttataat atattaatct atatattaat ttagaattct attctaattc
      961 gaattcaatt tttaaatatt cattcatatt caattaaaat tgaaattttt tcattcgcga
     1021 ggagccggat gagaagaaac tctcatgtcc ggttctgtag tagagatgga attaagaaaa
     1081 aaccatcaac tataacccca aaagaaccag attctgtaaa caacatagag gaagaatgaa
     1141 gggaatatct tatcggggga atcgtatttg tttcggaaaa tatgctctca ggcacga
//

LOCUS       HM041481                1200 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia palmadora ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041481
VERSION     HM041481.1  GI:330887240
KEYWORDS    .
SOURCE      chloroplast Opuntia palmadora
  ORGANISM  Opuntia palmadora
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1200)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1200)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1200
                     /organism="Opuntia palmadora"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001118"
     gene            <1..>1200
                     /gene="rpl16"
     misc_feature    <1098..>1200
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 tgatatacga aaagtaagag cccatagtat gaagtatgaa ctaataacta tagaactaat
       61 aaccaactca tcgcatcaca ttatctggat ccaaagaagc agtcaagata ggatattttg
      121 gtcctatcat tgcagcaact gaattttttt ttcataaaca agaaatcaaa tgagttgtca
      181 agcaaaagaa aaaaaaaaga aaaatatacn ttaaaggagg gggatgcgga taaatggaaa
      241 ggcgaaagaa agaaaaaaat gaatctaaat gatatacgat tccactatgt aaggtctttg
      301 aatcatatca taaaagacaa tgtaataaag catgaataca gattcacaca taattatctg
      361 atatgaatct attcatagaa aaaagaaaaa agtaagagcc tccgggccaa taaagactaa
      421 gagggttggg ctcaagaaca aagttcatta agagctccat tgtagaattc agacctaatc
      481 attaatcaag aagcgatggg aacgatgtaa tccatgaata cagaagattc aattgaaaaa
      541 gaatcctaat gattcattgg gaaggatggc ggaacgaacc agagaccaat tcatctattc
      601 tgaaaagtga taaactaatc ctataaaact aaaatagata ttgaaagagt aaatattcgc
      661 ccgcgaaaat tcctttttta ttaaattgct cacattttat tttagcaatg caatctaata
      721 aaatatatct atacaaaaaa atatagacaa actatatata taatatattt caaatttcct
      781 tatatatcct aatataaaaa tatctaataa attagatgaa tatcaaagaa tctattgatt
      841 tagtgtatta ttaaatgtat atcttaattc aatattatta ttctattcat ttttattatt
      901 catttttatt cattttcaaa tttagaatat attaatctat atattaattt agaattctat
      961 tctaattcga attcaatttt taaatattca tattcaatta aaattgaaat tttttcattc
     1021 gcgaggagcc ggatgagaag aaactctcac gtccggttct gtagtagagg tggaattaag
     1081 aaaaaaccat caactataac cccaaaagaa ccagattctg taaacaacat agaggaagaa
     1141 tgaagggaat atcttatcgg gggaatcgta tttgtttcgg aagatatgct ctcagcacga
//

LOCUS       HM041480                1153 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia microdasys ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041480
VERSION     HM041480.1  GI:330887239
KEYWORDS    .
SOURCE      chloroplast Opuntia microdasys
  ORGANISM  Opuntia microdasys
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1153)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1153)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1153
                     /organism="Opuntia microdasys"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:169217"
     gene            <1..>1153
                     /gene="rpl16"
     misc_feature    <1079..>1153
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gcccatagta tgaagtatga actaataact atagaactaa taaccaactc atcgcatcac
       61 attatctgga tccaaagaag cagtcaagat aggatatttt ggtcctatca ttgcagcaac
      121 tgaatttttt ttttcataaa caagaaatca aatgagttgt caagcaaaag aaaaaaaaaa
      181 aaaaaaatat actttaaggg ggggggatgg ggataaaggg aaaggggaaa aaaaaaaaaa
      241 aatgaatcta aatgatatac aattccacta tgaaaggtct ttgaatcata tcaaaaaaaa
      301 caatgtaata aagcaggaat acagattccc acataattat ctgatatgaa tcttttcata
      361 aaaaaaaaaa aaaagtaaga gcctccggcc aataaagact aagagggttg gctcaagaac
      421 aaagttcatt aagggctcca ttgtagaatt cagacctaat cattaatcaa gaggcgatgg
      481 gaacgatgta atccatgaat acagaagatt caattgaaaa agaatcctaa tgattcattg
      541 ggaaggatgg cggaacgaac cagagaccaa ttcatctatt ctgaaaagtg aaaaactaat
      601 cctataaaac taaaatagat attgaaagag taaatattcg cccgcgaaaa ttcctttttt
      661 attaaattgc tcacatttta ttttagcaat gcaatctaat aaaatatatc tatacaaaaa
      721 aatatagaca aactatatat ataatatatt tcaaatttcc ttatatatcc taatataaaa
      781 atatctaata aattagatga atatcaaaga atctattgat ttagtgtatt attaaatgta
      841 tatcttaatt caatattatt attctattca tttttattat tcatttttat tcattttcaa
      901 atttagaata tattaatcta tatattaatt tataattcta ttctaattcg aattcaattt
      961 ttaaatattc atattcaatt aaaattgaaa ttttttcatt cgcgaggagc cggatgagaa
     1021 gaaactctca cgtccggttc tgtagtagag gtggaattaa gaaaaaacca tcaactataa
     1081 ccccaaaaga accagattct gtaaacaaca tagaggaaga atgaagggaa tatcttatcg
     1141 ggggatatcg tat
//

LOCUS       HM041479                1197 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia megasperma ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041479
VERSION     HM041479.1  GI:330887238
KEYWORDS    .
SOURCE      chloroplast Opuntia megasperma
  ORGANISM  Opuntia megasperma
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1197
                     /organism="Opuntia megasperma"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001117"
     gene            <1..>1197
                     /gene="rpl16"
     misc_feature    <1098..>1197
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gatatacgaa aagtaagagc ccatagtatg aagtatgaac taataactat agaactaata
       61 accaactcat cgcatcacat tatccggatc caaagaagca gtcaagatag gatattttgg
      121 tcctatcatt gcagcaactg aatttttttt tcataaacaa gaaatcaaat gagttgtcaa
      181 gcaaaagaaa aaaaaaaaag aaaaatatac tttaaaggag ggggatgcgg ataaatggaa
      241 aggcgaaaga aagaaaaaaa tgaatctaaa tgatatacga ttccnctatg taaggtcttt
      301 gaatcatatc ataaaagaca atgtaataaa gcatgaatac agattcacac ataattatct
      361 gatatgaatc tattcataga aaaaagaaaa aagtaagagc ctccgggcca ataaagacta
      421 agagggttgg ctcaagaaca aagttcatta agagctccat tgtagaattc agacctaatc
      481 attaatcaag aagcgatggg aacgatgtaa tccatgaata cagaagattc aattgaaaaa
      541 gaatcctaat gattcattgg gaaggatggc ggaacgaacc agagaccaat tcatctattc
      601 tgaaaagtga taaactaatc ctataaaact aaaatagata ttgaaagagt aaatattcgc
      661 ccgcgaaaat tcctttttta ttaaattgct cacattttat tttagcaatg caatctaata
      721 aaatatatct atacaaaaaa atatagacaa actatatata taatatattt caaatttcct
      781 tatatatcct aatataaaaa tatctaataa attagatgaa tatcaaagaa tctattgatt
      841 tagtgtatta ttaaatgtat atcttaattc aatattttta ttctattcat ttttattatt
      901 catttttatt cattttcaaa tttagaatat attaatctat atattaattt agaattctat
      961 tctaattcga attcaatttt taaatattca tattcaatta aaattgaaat tttttcattc
     1021 gcgaggagcc ggatgagaag aaactctcac gtccggttct gtagtagagg tggaattaag
     1081 aaaaaaccat caactataac cccaaaagaa ccagattctg taaacaacat agaggaagaa
     1141 tgaagggaat atcttatcgg gggaatcgta tttgtttcgg aagatatgct ctcagca
//

LOCUS       HM041478                1187 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia macbridei ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041478
VERSION     HM041478.1  GI:330887237
KEYWORDS    .
SOURCE      chloroplast Opuntia macbridei
  ORGANISM  Opuntia macbridei
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1187)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1187)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1187
                     /organism="Opuntia macbridei"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001116"
     gene            <1..>1187
                     /gene="rpl16"
     misc_feature    <1090..>1187
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 aaaagtaaga gcccatagta tgaagtatga actaataact atagaactaa taaccaactc
       61 atcgcatcac attatctgga tccaaagaag cagtcaagat aggatatttt ggtcctatca
      121 ttgcagcaac tgaatttttt tttcataaac aagaaatcaa atgagttgtc aagcaaaaga
      181 aaaaaaaaaa agaaaaatat acattaaagg agggggatgc ggataaatgg aaaggcgaaa
      241 gaaagaaaaa aatgaatcta aatgatatac gattccacta tgtaaggtct ttgaatcata
      301 tcataaaaga caatgtaata aagcatgaat acagattcac acataattat ctgatatgaa
      361 tctattcata gaaaaaagaa aaaagtaaga gcctccggcc aataaagact aagagggttg
      421 gctcaagaac aaagttcatt aagggctcca tttgtagaat tcagacctaa tcattaatca
      481 agaagcgatg ggaacgatgt aattccatga atacagaaga ttcaattgaa aaagatccta
      541 atgattcatt gggaaggatg gcggacgaac cagagaccaa ttcatctatt ctgaaaagtg
      601 ataaactaat cctataaaac taaaatagat attgaaagag taaatattcg cccgcgaaaa
      661 ttcctttttt attaaattgc tcacatttta ttttagcaat gcaatctaat aaaatatatc
      721 tatacaaaaa aaatatagac aaactatata tataatatat ttcaaatttc cttatatatc
      781 ctaatataaa aatatctaat aatttagatg aatatcaaag aatctattga tttagtgtat
      841 tattaaatgt atatcttaat tcaatattat tattctattc atttttatta ttcattttta
      901 ttcattttca aatttagaat atattaatct atatattaat ttagaattct attctaattc
      961 gaattcaatt tttaaatatt catattcaat taaaattgaa attttttcat tcgcgaggag
     1021 ccggatgaga agaaactctc acgtccggtt ctgtagtaga ggtggaatta agaaaaaacc
     1081 atcaactata accccaaaag aaccagattc tgtaaacaac atagaggaag aatgaaggga
     1141 atatcttatc gggggaatcg tatttgtttc ggaagatatg ctctcag
//

LOCUS       HM041477                1197 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Cylindropuntia leptocaulis ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041477
VERSION     HM041477.1  GI:330887236
KEYWORDS    .
SOURCE      chloroplast Cylindropuntia leptocaulis
  ORGANISM  Cylindropuntia leptocaulis
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Cylindropuntia.
REFERENCE   1  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1197)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1197
                     /organism="Cylindropuntia leptocaulis"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:866983"
     gene            <1..>1197
                     /gene="rpl16"
     misc_feature    <1096..>1197
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 ttgtgngnct cctgaagagt aggagcccct agtatgaagt atgaactaat aactatagaa
       61 ctaataacca actcatcgca tcacattatc cggatccaaa aaagcagtca agataggata
      121 ttttggtcct atcattgcag caactgaatt ttttttttca taaacaagaa atcgaatgag
      181 ttgtcaagca aaagaaaaaa aaagaaaaat atactttaaa ggagggggat gcggataaat
      241 ggaaaggcga aagaaagaaa aaaatgaatc taaatgatat aggattcccc tatgtaaggt
      301 ctttgaatca tatcataaaa gacaatgtaa taaagcatga atacagattc ccacataatt
      361 atctgatatg aatctattcc tagaaaaaag aaaaaagtaa gagcctccgg ccaataaaga
      421 ctaagagggt tggctcaaga acaaagttca ttaaaagctc ccttgtagaa ttcagaccta
      481 atcnttaatc aagaagcgat gggaacgatg taatccctga atacagaaga ttcaattgaa
      541 aaagaatcct aatgattcat tgggaaggat ggcggaacga accagagacc aattcatcta
      601 ttctgaaaag tgataaacta atcctataaa actaaaatag atattgaaag agtaaatatt
      661 cgcccgcgaa atttcctttt ttattaaatt gctcatattt ttttttagca atgcaatcta
      721 ataaaatata tctctacaaa aaaacataga caaactatat atatatatat atataatatt
      781 tcaaattccc ttatatatcc aaatataaaa atatctaata aattagatga atatcaaaga
      841 atctattgat ttagtgtatt attaaatgta tatcttaatt caatattatt attctattca
      901 tttttattca ttttcaaatt tataatatat taatctatat attaatatag aattctattc
      961 taattcgaat tcaattttta aatattcata ttcaattaaa attgaaattt tttcattcgc
     1021 gaggagccgg atgagaagaa actctcatgt ccggttctgt agtagagatg gaattaagaa
     1081 aaaaccatca actataaccc caaaagaacc ggattctgta aacaacatag aggaagaatg
     1141 aagggaatat cttgtcgggg gaatcgatnn gtncggaant natgntcgcn gcgcgcc
//

LOCUS       HM041476                1205 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia lasiacantha ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041476
VERSION     HM041476.1  GI:330887235
KEYWORDS    .
SOURCE      chloroplast Opuntia lasiacantha
  ORGANISM  Opuntia lasiacantha
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1205)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1205)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1205
                     /organism="Opuntia lasiacantha"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:547104"
     gene            <1..>1205
                     /gene="rpl16"
     misc_feature    <1103..>1205
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gggcccnnna ngangaaaag tagagcccat agtatgaagt atgaactaat aactatagaa
       61 ctaataacca actcatcgca tcacattatc tggatccaaa gaagcagtca agataggata
      121 ttttggtcct atcattgcag caactgaatt ttttttttca taaacaagaa atcaaatgag
      181 ttgtcaagca aaagaaaaaa aaaaagaaaa atatccttta aaggaggggg atgcggataa
      241 atggaaaggc gaaagaaaga aaaaaatgaa tctaaatgat atacgattcc cctatgtaag
      301 gtctttgaat catatcataa aagacaatgt aataaagcat gaatacagat tcccccataa
      361 ttatctgata tgaatctatt cctagaaaaa agaaaaaagt aagagcctcc ggccaataaa
      421 gactaagagg gttggctcaa gaacaaagtt cattaagggc tccattgtag aattcagacc
      481 taatcattaa tcaagaggcg atgggaacga tgtaatccat gaatacagaa gattcaattg
      541 aaaaagaatc ctaatgattc attgggaagg atggcggaac gaaccagaga ccaattcatc
      601 tattctgaaa agtgataaac taatcctata aaactaaaat agatattgaa agagtaaata
      661 ttcgcccgcg aaaattcctt ttttattaaa ttgctcacat tttattttag caatgcaatc
      721 taataaaatc tatctataca aaaaaatata gacaaactat atatataata tatttcaaat
      781 ttccttatat atcctaatat aaaaatatct aataaattag atgaatatca aagaatctat
      841 tgatttagtg tattattaaa tgtatatctt aattcaatat tattattcta ttcattttta
      901 ttattcattt ttattcattt tcaaatttag aatatattaa tctatatatt aatttataat
      961 tctattctaa ttcgaattca atttttaaat attcatattc aattaaaatt gaaatttttt
     1021 cattcgcgag gagccggatg agaagaaact ctcacgtccg gttctgtagt agaggtggaa
     1081 ttaagaaaaa accatcaact ataaccccaa aagaaccaga ttctgtaaac aacatagagg
     1141 aagaatgaag ggaatatctt atcgagggaa tcgtatttgt ttcggaagat agtnctngcn
     1201 nggtg
//

LOCUS       HM041474                1163 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia helleri ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041474
VERSION     HM041474.1  GI:330887233
KEYWORDS    .
SOURCE      chloroplast Opuntia helleri
  ORGANISM  Opuntia helleri
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1163)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1163)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1163
                     /organism="Opuntia helleri"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001115"
     gene            <1..>1163
                     /gene="rpl16"
     misc_feature    <1081..>1163
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gagcccatag tatgaagtat gaactaataa ctatagaact aataaccaac tcatcgcatc
       61 acattatccg gatccaaaga agcagtcaag ataggatatt ttggtcctat cattgcagca
      121 actgaatttt tttttcataa acaagaaatc aaatgagttg tcaagcaaaa gaaaaaaaaa
      181 aaagaaaaat atacattaaa ggagggggat gcggataaat ggaaaggcga aagaaagaaa
      241 aaaatgaatc taaatgatat acgattccnc tatgtaaggt ctttgaatca tatcataaaa
      301 gacaatgtaa taaagcatga atacagattc acacataatt atctgatatg aatctattca
      361 tagaaaaaag aaaaaagtaa gagcctccgg ccaataaaga ctaagagggt tggctcaaga
      421 acaaagttca ttaagggctc cattgtagaa ttcagaccta atcattaatc aagaagcgat
      481 gggaacgatg taatccatga atacagaaga ttcaattgaa aaagaatcct aatgattcat
      541 tgggaaggat ggcggaacga accagagacc aattcatcta ttctgaaaag tgataaacta
      601 atcctataaa actaaaatag atattgaaag agtaaatatt cgcccgcgaa aattcctttt
      661 ttattaaatt gctcacattt tattttagca atgcaatcta ataaaatata tctatacaaa
      721 aaaatataga caaactatat atataatata tttaaaattt ccttatatat cctaatataa
      781 aaatatctaa taaattagat gaatatcaaa gaatctattg atttagtgta ttattaaatg
      841 tatatcttaa ttcaatattt ttattctatt catttttatt attcattttt attcattttc
      901 aaatttagaa tatattaatc tatatattaa tttagaattc tattctaatt cgaattcaat
      961 ttttaaatat tcatattcaa ttaaaattga aattttttca ttcgcgagga gccggatgag
     1021 aagaaactct cacgtccggt tctgtagtag aggtggaatt aagaaaaaac catcaactat
     1081 aaccccaaaa gaaccagatt ctgtaaacaa catagaggaa gaatgaaggg aatatcttat
     1141 cgggggaatc gtatttgttt cgg
//

LOCUS       HM041473                1203 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia excelsa ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041473
VERSION     HM041473.1  GI:330887232
KEYWORDS    .
SOURCE      chloroplast Opuntia excelsa
  ORGANISM  Opuntia excelsa
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1203)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1203)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1203
                     /organism="Opuntia excelsa"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:867487"
     gene            <1..>1203
                     /gene="rpl16"
     misc_feature    <1103..>1203
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 ccgnncnttg nnanacagaa nagtagagcc cnttntntga agtatgaact aatcactatt
       61 gaactaatcc ccnactcatc gcatcacatt atctggatcc aaagaagcag tcaagatagg
      121 atattttggt cctatcattg cagcaactga attttttttt tcctaaacaa gaaatcaaat
      181 gagttgtcaa gcaaaagaaa aaaaagaaaa atatacatta aaggaggggg atgcggataa
      241 atggaaaggc gaaagaaaga aaaaaatgaa tctaaatgat atacgattcc cctatgtaag
      301 gtctttgaat catatcataa aagacaatgt aataaagcat gaatacagat tcccacataa
      361 ttatctgata tgaatctatt catagaaaaa agaaaaaagt aagagcctcc ggccaataaa
      421 gactaaaagg gttggctcaa gaacaaagtt cattaagggc tccattgtaa aattcagacc
      481 taatcattaa tcaagaggcg atgggaacga tgtaatccat gaatacagaa gattcaattg
      541 aaaaagaatc ctaatgattc attgggaagg atggcggaac gaaccagaga ccaattcatc
      601 tattctgaaa agtgataaac taatcctata aaactaaaat agatattgaa agagtaaata
      661 ttcgcccgcg aaaattcctt ttttattaaa ttgctcacat tttattttag caatgcaatc
      721 taataaaatc tatctataca aaaaaatata gacaaactat atatataata tatttcaaat
      781 ttccttatat atcctaatat aaaaatatct aataaattag atgaatatca aagaatctat
      841 tgatttagtg tattattaaa tgtatatctt aattcaatat tattattcta ttcattttta
      901 ttattcattt ttattcattt tcaaatttag aatatattaa tctatatatt aatttagaat
      961 tctattctaa ttcgaattca atttttaaat attcatattc aattaaaatt gaaatttttt
     1021 cattcgcgag gagccggatg agaagaaact ctcacgtccg gttctgtagt agaggtggaa
     1081 ttaagaaaaa accatcaact ataaccccaa aagaaccaga ttctgtaaac aacatagagg
     1141 aagaatgaag ggaatatctt atcgggggaa tcgtatngtg cnggctngtg cancgcgggc
     1201 nng
//

LOCUS       HM041472                1182 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Opuntia echios ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041472
VERSION     HM041472.1  GI:330887231
KEYWORDS    .
SOURCE      chloroplast Opuntia echios
  ORGANISM  Opuntia echios
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1182)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1182)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1182
                     /organism="Opuntia echios"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:412453"
     gene            <1..>1182
                     /gene="rpl16"
     misc_feature    <1085..>1182
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gtaagagccc atagtatgaa gtatgaacta ataactatag aactaataac caactcatcg
       61 catcacatta tccggatcca aagaagcagt caagatagga tattttggtc ctatcattgc
      121 agcaactgaa tttttttttc ataaacaaga aatcaaatga gttgtcaagc aaaagaaaaa
      181 aaaaaaaaaa aaatatacat taaaggaggg ggatgcggat aaatggaaag gcgaaagaaa
      241 gaaaaaaatg aatctaaatg atatacgatt ccactatgta aggtctttga atcatatcat
      301 aaaagacaat gtaataaagc atgaatacag attcacacat aattatctga tatgaatcta
      361 ttcatagaaa aaagaaaaaa gtaagagcct ccggccaata aagactaaga ggttgggctc
      421 aagaacaaag ttcattaagg gctccattgt agaattcaga cctaatcatt aatcaagaag
      481 cgatgggaac gatgtaatcc atgaatacag aagattcaat tgaaaaagaa tcctaatgat
      541 tcattgggaa ggatggcgga acgaaccaga gaccaattca tctattctga aaagtgataa
      601 actaatccta taaaactaaa atagatattg aaagagtaaa tattcgcccg cgaaaattcc
      661 ttttttatta aattgctcac attttatttt agcaatgcaa tctaataaaa tatatctata
      721 caaaaaaata tagacaaact atatatataa tatatttcaa atttccttat atatcctaat
      781 ataaaaatat ctaataaatt agatgaatat caaagaatct attgatttag tgtattatta
      841 aatgtatatc ttaattcaat attattattc tattcatttt tattattcat ttttattcat
      901 tttcaaattt agaatatatt aatctatata ttaatttaga attctattct aattcgaatt
      961 caatttttaa atattcatat tcaattaaaa ttgaaatttt ttcattcgcg aggagccgga
     1021 tgagaagaaa ctctcacgtc cggttctgta gtagaggtgg aattaagaaa aaaccatcaa
     1081 ctataacccc aaaagaacca gattctgtaa acaacataga ggaagaatga agggaatatc
     1141 ttatcggggg aatcgtattt gtttcggaag atggctacta ta
//

LOCUS       HM041469                1189 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea sp. THH-2011 ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041469
VERSION     HM041469.1  GI:330887228
KEYWORDS    .
SOURCE      chloroplast Opuntia sp. THH-2011
  ORGANISM  Opuntia sp. THH-2011
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1189)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1189)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1189
                     /organism="Opuntia sp. THH-2011"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001114"
     gene            <1..>1189
                     /gene="rpl16"
     misc_feature    <1096..>1189
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 atatacgaaa aagtagagcc catagtatga agtatgaact aataactata gaactaataa
       61 ccaactcatc gcatcacatt atctggatcc aaagaagcag tcaagatagg atattttggt
      121 cctatcattg cagcaactga attttttttt cataaacaag aaatcaaatg agttgtcaag
      181 caaaagaaaa aaaaaaaaga aaaatatact ttaagggagg gggatgcgga taaatggaaa
      241 ggcgaaagaa agaaaaaaat gaatctaaat gatatacgat tccactatgt aaggtctttg
      301 aatcatatca taaaagacaa tgtaataaag catgaataca gattcacaca taattatctg
      361 gtatgaatct attcatagaa aaaagaaaaa agtaagaccc tccggccaat aaagactaag
      421 agggttggct caagaacaaa gttcattaag ggctccattg tagaattcag acctaatcat
      481 taatcaagaa gcgatgggaa cgatgtaatc catgaataca gaagattcaa ttgaaaaaga
      541 atcctaatga ttcattggga aggatggcgg aacgaaccag agaccaattc atctattctg
      601 aaaagtgata aactaatcct ataaaactaa aatagatatt gaaagagtaa atattcgccc
      661 gcgaaaattc cttttttatt aaattgctca cattttattt tagcaatgca atctaataaa
      721 atatatctat acaaaaaaat atagacaaac tatatatata atatatttca aatttcctta
      781 tatatcctaa tataaaaata tctaataaat tagatgaata tcaaagaatc tattgattta
      841 gtgtattatt aaatgtatat cttaattcaa tattattatt ctattcattt ttattattca
      901 tttttattca ttttcaaatt tagaatatat taatctatat attaatttag aattctattc
      961 taattcgaat tcaattttta aatattcata ttcaattaaa attgaaattt tttcattcgc
     1021 gaggagccgg atgagaagaa actctcacgt ccggttctgt agtagaggtg gaattaagaa
     1081 aaaaccatca actataaccc caaaagaacc agattctgta aacaacatag aggaagaatg
     1141 aagggaatat cttatcgggg gaatcgtatt tgtttcggaa gatatgctc
//

LOCUS       HM041468                1202 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea lutea ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041468
VERSION     HM041468.1  GI:330887227
KEYWORDS    .
SOURCE      chloroplast Opuntia lutea
  ORGANISM  Opuntia lutea
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1202)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1202)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1202
                     /organism="Opuntia lutea"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001113"
     gene            <1..>1202
                     /gene="rpl16"
     misc_feature    <1099..>1202
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gatatacgaa aaagtaagag cccatagtat gaagtatgaa ctaataacta tagaactaat
       61 aaccaactca tcgcatcaca ttatctggat ccaaagaagc agtcaagata ggatattttg
      121 gtcctatcat tgcagcaact gaattttttt ttcataaaca agaaatcaaa tgagttgtca
      181 agcaaaagaa aaaaaaaaaa gaaaaatata ctttaaggga gggggatgcg gataaatgga
      241 aaggcgaaag aaagaaaaaa atgaatctaa atgatatacg attcccccta tgtaaggtct
      301 ttgaatcata tcataaaaga caatgtaata aagcatgaat acagattcac acataattat
      361 ctgatatgaa tctattcata gaaaaaagaa aaaagtaaga ccctccggcc aataaagact
      421 aagagggttg gctcaagaac aaagttcatt aagggctcca ttgtagaatt cagacctaat
      481 cattaatcaa gaagcgatgg gaacgatgta atccatgaat acagaagatt caattgaaaa
      541 agaatcctaa tgattcattg ggaaggatgg cggaacgaac cagagaccaa ttcatctatt
      601 ctgaaaagtg ataaactaat cctataaaac taaaatagat attgaaagag taaatattcg
      661 cccgcgaaaa ttcctttttt attaaattgc tcacatttta ttttagcaat gcaatctaat
      721 aaaatatatc tatacaaaaa aatatagaca aactatatat ataatatatt tcaaatttcc
      781 ttatatatcc taatataaaa atatctaata aattagatga atatcaaaga atctattgat
      841 ttagtgtatt attaaatgta tatcttaatt caatattatt attctattca tttttattat
      901 tcatttttat tcattttcaa atttagaata tattaatcta tatattaatt tagaattcta
      961 ttctaattcg aattcaattt ttaaatattc atattcaatt aaaattgaaa ttttttcatt
     1021 cgcgaggagc cggatgagaa gaaactctca cgtccggttc tgtagtagag gtggaattaa
     1081 gaaaaaacca tcaactataa ccccaaaaga accagattct gtaaacaaca tagaggaaga
     1141 atgaagggaa tatcttatcg ggggaatcgt atttgtttcg gaagatatgc tctcaggcac
     1201 ga
//

LOCUS       HM041467                1199 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea karwinskiana ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041467
VERSION     HM041467.1  GI:330887226
KEYWORDS    .
SOURCE      chloroplast Opuntia karwinskiana
  ORGANISM  Opuntia karwinskiana
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1199)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1199)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1199
                     /organism="Opuntia karwinskiana"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001112"
     gene            <1..>1199
                     /gene="rpl16"
     misc_feature    <1098..>1199
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gtgatatcga aaaagtagag cccatagtat gaagtatgaa ctaataacta tagaactaat
       61 aaccaactca tcgcatcaca ttatctggat ccaaagaagc agtcaagata ggatattttg
      121 gtcctatcat tgcagcaact gaattttttt ttcataaaca agaaatcaaa tgagttgtca
      181 agcaaaagaa aaaaaaaaaa gaaaaattta ctttaaggga gggggatgcg gataaatgga
      241 aaggcgaaag aaagaaaaaa atgaatctaa atgatatacg attcccctat gtagggtctt
      301 tgaatcatat cataaaaaac aatgtaataa agcatgaata cagattcccc cataattatc
      361 tggtatgaat cttttcatag aaaaaaaaaa aaagtaagag cctccggcca ataaaaacta
      421 aaagggttgg ctcaagaaca aagttcatta agggctccat tgtagaattc agacctaatc
      481 nttaatcaag aagcgatggg aacgatgtaa tccatgaata cagaagattc aattgaaaaa
      541 gaatcctaat gattcattgg gaaggatggc ggaacgaacc agagaccaat tcatctattc
      601 tgaaaagtga taaactaatc ctataaaact aaaatagata ttgaaagagt aaatattcgc
      661 ccgcgaaaat tcctttttta ttaaattgct cacattttat tttagcaatg caatctaata
      721 aaatatatct atacaaaaaa atatagacaa actatatata taatatattt caaatttcct
      781 tatatatcct aatataaaaa tatctaataa attagatgaa tatcaaagaa tctattgatt
      841 tagtgtatta ttaaatgtat atcttaattc aatattatta ttctattcat ttttattatt
      901 catttttatt cattttcaaa tttagaatat attaatctat atattaattt agaattctat
      961 tctaattcga attcaatttt taaatattca tattcaatta aaattgaaat tttttcattc
     1021 gcgaggagcc ggatgagaag aaactctcac gtccggttct gtagtagagg tggaattaag
     1081 aaaaaaccat caactataac cccaaaagaa ccagattctg taaacaacat agaggaagaa
     1141 tgaagggaat atcttatgcg ggggaatcgt attgtttcgg aagatatgct ctgcggccc
//

LOCUS       HM041466                1205 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea gaumeri ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041466
VERSION     HM041466.1  GI:330887225
KEYWORDS    .
SOURCE      chloroplast Nopalea gaumeri
  ORGANISM  Nopalea gaumeri
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1205)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1205)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1205
                     /organism="Nopalea gaumeri"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001111"
     gene            <1..>1205
                     /gene="rpl16"
     misc_feature    <1103..>1205
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gctgtgatat acgaaanagt aagagcccat agtatgaagt atgaactaat aactatagaa
       61 ctaataacca actcatcgca tcacattatc tggatccaaa gaagcagtca agataggata
      121 ttttggtcct atcattgcag caactgaatt tttttttcat aaacaagaaa tcaaatgagt
      181 tgtcaagcaa aagaaaaaaa aaaaaaaaaa tatacattaa aggaggggga tgcggataaa
      241 tggaaaggcg aaagaaagaa aaaaatgaat ctaaatgata tacgattcca ctatgtaagg
      301 tctttgaatc atatcataaa agacaatgta ataaagcatg aatacagatt cacacataat
      361 tatctgaata tgaatctatt catagaaaaa agaaaaaagt aagaccctcc ggccaataaa
      421 gactaaaggg gttggctcaa gaacaaagtt cattaagggc tccattgtag aattcagacc
      481 taatcattaa tcaagaagcg atgggaacga tgtaatccat gaatacagaa gattcaattg
      541 aaaaagaatc ctaatgattc attgggaagg atggcggaac gaaccagaga ccaattcatc
      601 tattctgaaa agtgataaac taatcctata aaactaaaat agatattgaa agagtaaata
      661 ttcgcccgcg aaaattcctt ttttattaaa ttgctcacat tttattttag caatgcaatc
      721 taataaaata tatctataca aaaaaatata gacaaactat atatataata tatttcaaat
      781 ttccttatat atcctaatat aaaaatatct aataaattag atgaatatca aagaatctat
      841 tgatttagtg tattattaaa tgtatatctt aattcaatat tattattcta ttcattttta
      901 ttattcattt ttattcattt tcaaatttag aatatattaa tctatatatt aatttagaat
      961 tctattctaa ttcgaattca atttttaaat attcatattc aattaaaatt gaaatttttt
     1021 cattcgcgag gagccggatg agaagaaact ctcacgtccg gttctgtagt agaggtggaa
     1081 ttaagaaaaa accatcaact ataaccccaa aagaaccaga ttctgtaaac aacatagagg
     1141 aagaatgaag ggaatatctt atcgggggaa tcgtatttgt ttcggaagat atgctctcag
     1201 cacga
//

LOCUS       HM041465                1190 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea dejecta ribosomal protein L16-like (rpl16) gene, partial
            sequence; chloroplast.
ACCESSION   HM041465
VERSION     HM041465.1  GI:330887224
KEYWORDS    .
SOURCE      chloroplast Opuntia dejecta
  ORGANISM  Opuntia dejecta
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1190)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1190)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1190
                     /organism="Opuntia dejecta"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:1001110"
     gene            <1..>1190
                     /gene="rpl16"
     misc_feature    <1096..>1190
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 tgatatacga aanagtaaga gcccatagta tgaagtatga actaataact atagaactaa
       61 taaccaactc atcgcatcac attatctgga tccaaagaag cagtcaagat aggatatttt
      121 ggtcctatca ttgcagcaac tgaatttttt tttcataaac aagaaatcaa atgagttgtc
      181 aagcaaaaga aaaaaaaaaa aaaaaatata ctttaangga gggggatgcg gataaatgga
      241 aaggcgaaag aaagaaaaaa atgaatctaa atgatatacg attccactat gtaaggtctt
      301 tgaatcatat cataaaagac aatgtaataa agcatgaata cagattcaca cataattatc
      361 tgtatgatct attcatagaa aaaagaaaaa agtaagagcc tccggccaat aaagactaag
      421 agggttggct caagaacaaa gttcattaag ggctccattg tagaattcag acctaatcat
      481 taatcaagaa gcgatgggaa cgatgtaatc catgaataca gaagattcaa ttgaaaaaga
      541 atcctaatga ttcattggga aggatggcgg aacgaaccag agaccaattc atctattctg
      601 aaaagtgata aactaatcct ataaaactaa aatagatatt gaaagagtaa atattcgccc
      661 gcgaaaattc cttttttatt aaattgctca cattttattt tagcaatgca atctaataaa
      721 atatatctat acaaaaaaat atagacaaac tatatatata atatatttca aatttcctta
      781 tatatcctaa tataaaaata tctaataaat tagatgaata tcaaagaatc tattgattta
      841 gtgtattatt aaatgtatat cttaattcaa tattattatt ctattcattt ttattattca
      901 tttttattca ttttcaaatt tagaatatat taatctatat attaatttag aattctattc
      961 taattcgaat tcaattttta aatattcata ttcaattaaa attgaaattt tttcattcgc
     1021 gaggagccgg atgagaagaa actctcacgt ccggttctgt agtagaggtg gaattaagaa
     1081 aaaaccatca actataaccc caaaagaacc agattctgta aacaacatag aggaagaatg
     1141 aagggaatat cttatcgggg gaatcgtatt tgtttcggaa gatatgctct
//

LOCUS       HM041464                1184 bp    DNA     linear   PLN 03-MAY-2011
DEFINITION  Nopalea cochenillifera ribosomal protein L16-like (rpl16) gene,
            partial sequence; chloroplast.
ACCESSION   HM041464
VERSION     HM041464.1  GI:330887223
KEYWORDS    .
SOURCE      chloroplast Opuntia cochenillifera
  ORGANISM  Opuntia cochenillifera
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 1184)
  AUTHORS   Hernandez-Hernandez,T., Hernandez,H.M., De-Nova,J.A., Puente,R.,
            Eguiarte,L.E. and Magallon,S.
  TITLE     Phylogenetic relationships and evolution of growth form in
            Cactaceae (Caryophyllales, Eudicotyledoneae)
  JOURNAL   Am. J. Bot. 98 (1), 44-61 (2011)
   PUBMED   21613084
REFERENCE   2  (bases 1 to 1184)
  AUTHORS   Hernandez-Hernandez,T., Magallon,S.A., Hernandez,H.M., De-Nova,A.,
            Puente,R. and Eguiarte,L.E.
  TITLE     Direct Submission
  JOURNAL   Submitted (17-MAR-2010) Departamento de Botanica, Instituto de
            Biologia, Universidad Nacional Autonoma de Mexico, 3er Circuito de
            Ciudad Universitaria, Ciudad Universitaria, Coyoacan, Distrito
            Federal C.P. 04510, Mexico
FEATURES             Location/Qualifiers
     source          1..1184
                     /organism="Opuntia cochenillifera"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:338184"
     gene            <1..>1184
                     /gene="rpl16"
     misc_feature    <1102..>1184
                     /gene="rpl16"
                     /note="similar to ribosomal protein L16"
ORIGIN
        1 gctgtgatat acgaaaaagt aagagcccat agtatgaagt atgaactaac aactatagaa
       61 ctaataacca actcatcgca tcacattatc tggatccaaa gaagcagtca agataggata
      121 ttttggtcct atcattgcag caactgaatt tttttttcat aaacaagaaa tcaaatgagt
      181 tgtcaagcaa aagaaaaaaa aaaaaaaaaa tatactttaa aggaggggga tgcggataaa
      241 tggaaaggcg aaagaaagaa aaaaatgaat ctaaatgata tacgattcca ctatgtaagg
      301 tctttgaatc atatcataaa agacaatgta ataaagcatg aatacagatt cccacataat
      361 tatctgatat gaatctattc atagaaaaaa gaaaaaagta agagcctccg gccaataaag
      421 actaagaggg ttggctcaag aacaaagttc attaagggct ccattgtaga attcagacct
      481 aatcattaat caagaagcga tgggaacgat gtaatccatg aatacagaag attcaattga
      541 aaaagaatcc taatgattca ttgggaagga tggcggaacg aaccagagac caattcatct
      601 attctgaaaa gtgataaact aatcctataa aactaaaata gatattgaaa gagtaaatat
      661 tcgcccgcga aaattccttt tttattaaat tgctcacatt ttattttagc aatgcaatct
      721 aataaaatat atctatacaa aaaaatatag acaaactata tatataatat atttcaaatt
      781 tccttatata tcctaatata aaaatatcta ataaattaga tgaatatcaa agaatctatt
      841 gatttagtgt attattaaat gtatatctta attcaatatt attattctat tcatttttat
      901 tattcatttt tattcatttt caaatttaga atatattaat ctatatatta atttagaatt
      961 ctattctaat tcgaattcaa tttttaaata ttcatattca attaaaattg aaattttttc
     1021 attcgcgagg agccggatga gaagaaactc tcacgtccgg ttctgtagta gaggtggaat
     1081 taagaaaaaa ccatcaacta taaccccaaa agaaccagat tctgtaaaca acatagagga
     1141 agaatgaagg gaatatctta tcgggggaat cgtatttgtt tcgg
//

LOCUS       AY851612                 892 bp    DNA     linear   PLN 10-APR-2007
DEFINITION  Opuntia subulata rpl16 gene, intron; chloroplast.
ACCESSION   AY851612
VERSION     AY851612.1  GI:57240072
KEYWORDS    .
SOURCE      chloroplast Austrocylindropuntia subulata
  ORGANISM  Austrocylindropuntia subulata
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Austrocylindropuntia.
REFERENCE   1  (bases 1 to 892)
  AUTHORS   Butterworth,C.A. and Wallace,R.S.
  TITLE     Molecular Phylogenetics of the Leafy Cactus Genus Pereskia
            (Cactaceae)
  JOURNAL   Syst. Bot. 30 (4), 800-808 (2005)
REFERENCE   2  (bases 1 to 892)
  AUTHORS   Butterworth,C.A. and Wallace,R.S.
  TITLE     Direct Submission
  JOURNAL   Submitted (10-DEC-2004) Desert Botanical Garden, 1201 North Galvin
            Parkway, Phoenix, AZ 85008, USA
FEATURES             Location/Qualifiers
     source          1..892
                     /organism="Austrocylindropuntia subulata"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:106982"
     gene            <1..>892
                     /gene="rpl16"
     intron          <1..>892
                     /gene="rpl16"
ORIGIN
        1 cattaaagaa gggggatgcg gataaatgga aaggcgaaag aaagaaaaaa atgaatctaa
       61 atgatatacg attccactat gtaaggtctt tgaatcatat cataaaagac aatgtaataa
      121 agcatgaata cagattcaca cataattatc tgatatgaat ctattcatag aaaaaagaaa
      181 aaagtaagag cctccggcca ataaagacta agagggttgg ctcaagaaca aagttcatta
      241 agagctccat tgtagaattc agacctaatc attaatcaag aagcgatggg aacgatgtaa
      301 tccatgaata cagaagattc aattgaaaaa gatcctaatg atcattggga aggatggcgg
      361 aacgaaccag agaccaattc atctattctg aaaagtgata aactaatcct ataaaactaa
      421 aatagatatt gaaagagtaa atattcgccc gcgaaaattc cttttttatt aaattgctca
      481 tattttattt tagcaatgca atctaataaa atatatctat acaaaaaaat atagacaaac
      541 tatatatata taatatattt caaatttcct tatataccca aatataaaaa tatctaataa
      601 attagatgaa tatcaaagaa tctattgatt tagtgtatta ttaaatgtat atcttaattc
      661 aatattatta ttctattcat ttttattcat tttcaaattt ataatatatt aatctatata
      721 ttaatttata attctattct aattcgaatt caatttttaa atattcatat tcaattaaaa
      781 ttgaaatttt ttcattcgcg aggagccgga tgagaagaaa ctctcatgtc cggttctgta
      841 gtagagatgg aattaagaaa aaaccatcaa ctataacccc aagagaacca ga
//

LOCUS       AY851611                 881 bp    DNA     linear   PLN 10-APR-2007
DEFINITION  Opuntia polyacantha rpl16 gene, intron; chloroplast.
ACCESSION   AY851611
VERSION     AY851611.1  GI:57240071
KEYWORDS    .
SOURCE      chloroplast Opuntia polyacantha
  ORGANISM  Opuntia polyacantha
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Opuntia.
REFERENCE   1  (bases 1 to 881)
  AUTHORS   Butterworth,C.A. and Wallace,R.S.
  TITLE     Molecular Phylogenetics of the Leafy Cactus Genus Pereskia
            (Cactaceae)
  JOURNAL   Syst. Bot. 30 (4), 800-808 (2005)
REFERENCE   2  (bases 1 to 881)
  AUTHORS   Butterworth,C.A. and Wallace,R.S.
  TITLE     Direct Submission
  JOURNAL   Submitted (10-DEC-2004) Desert Botanical Garden, 1201 North Galvin
            Parkway, Phoenix, AZ 85008, USA
FEATURES             Location/Qualifiers
     source          1..881
                     /organism="Opuntia polyacantha"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:307728"
     gene            <1..>881
                     /gene="rpl16"
     intron          <1..>881
                     /gene="rpl16"
ORIGIN
        1 cattaaagga gggggatgcg gataaatgga aaggcgaaag aaagaaaaaa atgaatctaa
       61 atgatatacg attccactat gtaaggtctt tgaatcatat cataaaagac aatgtaataa
      121 agcatgaata cagattcaca cataattatc tgatatgaat ctattcatag aaaaaagaaa
      181 aaagtaagag cctccggcca ataaagacta agagggttgg ctcaagaaca aagttcatta
      241 agggctccat tgtagaattc agacctaatc attaatcaag aagcgatggg aacgatgtaa
      301 tccatgaata cagaagattc aattgaaaaa gatcctaatg atcattggga aggatggcgg
      361 aacgaaccag agaccaattc atctattctg aaaagtgata aactaatcct ataaaactaa
      421 aatagatatt gaaagagtaa atattcgccc gcgaaaattc cttttttatt aaattgctca
      481 cattttattt tagcaatgca atctaataaa atatatctat acaaaaaaat atagacaaac
      541 tctatatata atatatttca aatttcctta tatatcctaa tataaaaata tctaataaat
      601 tagatgaata tcaaagaatc tattgattta gtgtattatt aaatgtatat cttaattcaa
      661 tattattatt ctattcattt tcaaatttag aatatattaa tctatatatt aatttagaat
      721 tctattctaa ttcgaattca atttttaaat attcatattc aattaaaatt gaaatttttt
      781 cattcgcgag gagccggatg agaagaaact ctcacgtccg gttactgtag tagaggtgga
      841 attaagaaaa aaccatcaac tataacccca aaagaaccag a
//

LOCUS       AF191661                 895 bp    DNA     linear   PLN 07-NOV-1999
DEFINITION  Opuntia kuehnrichiana rpl16 gene; chloroplast gene for chloroplast
            product, partial intron sequence.
ACCESSION   AF191661
VERSION     AF191661.1  GI:6273287
KEYWORDS    .
SOURCE      chloroplast Cumulopuntia sphaerica
  ORGANISM  Cumulopuntia sphaerica
            Eukaryota; Viridiplantae; Streptophyta; Embryophyta; Tracheophyta;
            Spermatophyta; Magnoliophyta; eudicotyledons; Gunneridae;
            Pentapetalae; Caryophyllales; Cactineae; Cactaceae; Opuntioideae;
            Cumulopuntia.
REFERENCE   1  (bases 1 to 895)
  AUTHORS   Dickie,S.L. and Wallace,R.S.
  TITLE     Phylogeny of the subfamily Opuntioideae (Cactaceae)
  JOURNAL   Unpublished
REFERENCE   2  (bases 1 to 895)
  AUTHORS   Dickie,S.L. and Wallace,R.S.
  TITLE     Direct Submission
  JOURNAL   Submitted (28-SEP-1999) Botany, Iowa State University, 353 Bessey
            Hall, Ames, IA 50011-1020, USA
FEATURES             Location/Qualifiers
     source          1..895
                     /organism="Cumulopuntia sphaerica"
                     /organelle="plastid:chloroplast"
                     /mol_type="genomic DNA"
                     /db_xref="taxon:106979"
                     /note="subfamily Opuntioideae; synonym: Cumulopuntia
                     kuenrichiana"
     gene            <1..>895
                     /gene="rpl16"
     intron          <1..>895
                     /gene="rpl16"
ORIGIN
        1 tatacattaa agaaggggga tgcggataaa tggaaaggcg aaagaaagaa aaaaatgaat
       61 ctaaatgata tacgattcca ctatgtaagg tctttgaatc atatcataaa agacaatgta
      121 ataaagcatg aatacagatt cacacataat tatctgatat gaatctattc atagaaaaaa
      181 gaaaaaagta agagcctccg gccaataaag actaagaggg ttggctcaag aacaaagttc
      241 attaagagct ccattgtaga attcagacct aatcattaat caagaagcga tgggaacgat
      301 gtaatccatg aatacagaag attcaattga aaaagatcct atgatccatt gggaaggatg
      361 gcggaacgaa ccagagacca attcatctat tctgaaaagt gataaactaa tcctataaaa
      421 ctaaaataga tattgaaaga gtaaatattc gcccgcgaaa attccttttt tttttaaatt
      481 gctcatattt tattttagca atgcaatcta ataaaatata tctatacaaa aaaataaaga
      541 caaactatat atataatata tttcaaattt ccttatatat ccaaatataa aaatatctaa
      601 taaattagat gaatatcaaa gaatctattg atttagtgta ttattaaatg tatatcttaa
      661 ttcaatatta ttattctatt catttttatt cattttcaat tttataatat attaatctat
      721 atattaattt ataattctat tctaattcga attcaatttt taaatattca tattcaatta
      781 aaattgaaat tttttcattc gcgaggagcc ggatgagaag aaactctcat gtccggttct
      841 gtagtagaga tggaattaag aaaaaaccat caactataac cccaagagaa ccaga
//


In this case, we are just getting the raw records. To get the records in a more Python-friendly form, we can use Bio.SeqIO to parse the GenBank data into SeqRecord objects, including SeqFeature objects (see Chapter [chapter:Bio.SeqIO]):

In [79]:
from Bio import SeqIO
handle = Entrez.efetch(db="nuccore", id=gi_str, rettype="gb", retmode="text")
records = SeqIO.parse(handle, "gb")

We can now step through the records and look at the information we are interested in:

In [80]:
for record in records:
    print("%s, length %i, with %i features" \
    % (record.name, len(record), len(record.features)))
HQ621368, length 399, with 3 features
HM041482, length 1197, with 3 features
HM041481, length 1200, with 3 features
HM041480, length 1153, with 3 features
HM041479, length 1197, with 3 features
HM041478, length 1187, with 3 features
HM041477, length 1197, with 3 features
HM041476, length 1205, with 3 features
HM041474, length 1163, with 3 features
HM041473, length 1203, with 3 features
HM041472, length 1182, with 3 features
HM041469, length 1189, with 3 features
HM041468, length 1202, with 3 features
HM041467, length 1199, with 3 features
HM041466, length 1205, with 3 features
HM041465, length 1190, with 3 features
HM041464, length 1184, with 3 features
AY851612, length 892, with 3 features
AY851611, length 881, with 3 features
AF191661, length 895, with 3 features

Using these automated query retrieval functionality is a big plus over doing things by hand. Although the module should obey the NCBI’s max three queries per second rule, the NCBI have other recommendations like avoiding peak hours. See Section [sec:entrez-guidelines]. In particular, please note that for simplicity, this example does not use the WebEnv history feature. You should use this for any non-trivial search and download work, see Section History and WebEnv.

Finally, if plan to repeat your analysis, rather than downloading the files from the NCBI and parsing them immediately (as shown in this example), you should just download the records once and save them to your hard disk, and then parse the local file.

Finding the lineage of an organism

Staying with a plant example, let’s now find the lineage of the Cypripedioideae orchid family. First, we search the Taxonomy database for Cypripedioideae, which yields exactly one NCBI taxonomy identifier:

In [81]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"     # Always tell NCBI who you are
handle = Entrez.esearch(db="Taxonomy", term="Cypripedioideae")
record = Entrez.read(handle)
record["IdList"]

Out[81]:
['158330']
In [82]:
record["IdList"][0]

Out[82]:
'158330'

Now, we use efetch to download this entry in the Taxonomy database, and then parse it:

In [83]:
handle = Entrez.efetch(db="Taxonomy", id="158330", retmode="xml")
records = Entrez.read(handle)

Again, this record stores lots of information:

In [84]:
records[0].keys()

Out[84]:
dict_keys(['PubDate', 'ScientificName', 'Division', 'MitoGeneticCode', 'GeneticCode', 'CreateDate', 'Rank', 'ParentTaxId', 'LineageEx', 'TaxId', 'Lineage', 'UpdateDate', 'OtherNames'])

We can get the lineage directly from this record:

In [85]:
records[0]["Lineage"]

Out[85]:
'cellular organisms; Eukaryota; Viridiplantae; Streptophyta; Streptophytina; Embryophyta; Tracheophyta; Euphyllophyta; Spermatophyta; Magnoliophyta; Mesangiospermae; Liliopsida; Petrosaviidae; Asparagales; Orchidaceae'

The record data contains much more than just the information shown here - for example look under LineageEx instead of Lineage and you’ll get the NCBI taxon identifiers of the lineage entries too.

Using the history and WebEnv

Often you will want to make a series of linked queries. Most typically, running a search, perhaps refining the search, and then retrieving detailed search results. You can do this by making a series of separate calls to Entrez. However, the NCBI prefer you to take advantage of their history support - for example combining ESearch and EFetch.

Another typical use of the history support would be to combine EPost and EFetch. You use EPost to upload a list of identifiers, which starts a new history session. You then download the records with EFetch by referring to the session (instead of the identifiers).

Searching for and downloading sequences using the history

Suppose we want to search and download all the Opuntia rpl16 nucleotide sequences, and store them in a FASTA file. As shown in Section [sec:entrez-search-fetch-genbank], we can naively combine Bio.Entrez.esearch() to get a list of GI numbers, and then call Bio.Entrez.efetch() to download them all.

However, the approved approach is to run the search with the history feature. Then, we can fetch the results by reference to the search results - which the NCBI can anticipate and cache.

To do this, call Bio.Entrez.esearch() as normal, but with the additional argument of usehistory="y",

In [86]:
from Bio import Entrez
Entrez.email = "history.user@example.com"
search_handle = Entrez.esearch(db="nucleotide",term="Opuntia[orgn] and rpl16", usehistory="y")
search_results = Entrez.read(search_handle)
search_handle.close()

When you get the XML output back, it will still include the usual search results. However, you also get given two additional pieces of information, the WebEnv session cookie, and the QueryKey:

In [87]:
gi_list = search_results["IdList"]
count = int(search_results["Count"])
assert count == len(gi_list)
print("The WebEnv is {}".format(search_results["WebEnv"]))
print("The QueryKey is {}".format(search_results["QueryKey"]))
The WebEnv is NCID_1_946410500_130.14.18.34_9001_1452651901_1799213676_0MetA0_S_MegaStore_F_1
The QueryKey is 1

Having stored these values in variables session_cookie and query_key we can use them as parameters to Bio.Entrez.efetch() instead of giving the GI numbers as identifiers.

While for small searches you might be OK downloading everything at once, it is better to download in batches. You use the retstart and retmax parameters to specify which range of search results you want returned (starting entry using zero-based counting, and maximum number of results to return). Sometimes you will get intermittent errors from Entrez, HTTPError 5XX, we use a try except pause retry block to address this. For example,

from Bio import Entrez
import time
try:
    from urllib.error import HTTPError  # for Python 3
except ImportError:
    from urllib2 import HTTPError  # for Python 2
batch_size = 3
out_handle = open("orchid_rpl16.fasta", "w")
for start in range(0, count, batch_size):
    end = min(count, start+batch_size)
    print("Going to download record %i to %i" % (start+1, end))
    attempt = 1
    while attempt <= 3:
        try:
            fetch_handle = Entrez.efetch(db="nucleotide", rettype="fasta", retmode="text",
                                         retstart=start, retmax=batch_size,
                                         webenv=webenv, query_key=query_key)
        except HTTPError as err:
            if 500 <= err.code <= 599:
                print("Received error from server %s" % err)
                print("Attempt %i of 3" % attempt)
                attempt += 1
                time.sleep(15)
            else:
                raise
    data = fetch_handle.read()
    fetch_handle.close()
    out_handle.write(data)
out_handle.close()

For illustrative purposes, this example downloaded the FASTA records in batches of three. Unless you are downloading genomes or chromosomes, you would normally pick a larger batch size.

Searching for and downloading abstracts using the history

Here is another history example, searching for papers published in the last year about the Opuntia, and then downloading them into a file in MedLine format:

from Bio import Entrez
import time
try:
    from urllib.error import HTTPError  # for Python 3
except ImportError:
    from urllib2 import HTTPError  # for Python 2
Entrez.email = "history.user@example.com"
search_results = Entrez.read(Entrez.esearch(db="pubmed",
                                            term="Opuntia[ORGN]",
                                            reldate=365, datetype="pdat",
                                            usehistory="y"))
count = int(search_results["Count"])
print("Found %i results" % count)

batch_size = 10
out_handle = open("recent_orchid_papers.txt", "w")
for start in range(0,count,batch_size):
    end = min(count, start+batch_size)
    print("Going to download record %i to %i" % (start+1, end))
    attempt = 1
    while attempt <= 3:
        try:
            fetch_handle = Entrez.efetch(db="pubmed",rettype="medline",
                                         retmode="text",retstart=start,
                                         retmax=batch_size,
                                         webenv=search_results["WebEnv"],
                                         query_key=search_results["QueryKey"])
        except HTTPError as err:
            if 500 <= err.code <= 599:
                print("Received error from server %s" % err)
                print("Attempt %i of 3" % attempt)
                attempt += 1
                time.sleep(15)
            else:
                raise
    data = fetch_handle.read()
    fetch_handle.close()
    out_handle.write(data)
out_handle.close()

At the time of writing, this gave 28 matches - but because this is a date dependent search, this will of course vary. As described in Section [subsec:entrez-and-medline] above, you can then use Bio.Medline to parse the saved records.

Searching for citations

Back in Section [sec:elink] we mentioned ELink can be used to search for citations of a given paper. Unfortunately this only covers journals indexed for PubMed Central (doing it for all the journals in PubMed would mean a lot more work for the NIH). Let’s try this for the Biopython PDB parser paper, PubMed ID 14630660:

In [88]:
from Bio import Entrez
Entrez.email = "A.N.Other@example.com"
pmid = "14630660"
results = Entrez.read(Entrez.elink(dbfrom="pubmed", db="pmc",
LinkName="pubmed_pmc_refs", from_uid=pmid))
pmc_ids = [link["Id"] for link in results[0]["LinkSetDb"][0]["Link"]]
pmc_ids
Out[88]:
['4595337',
 '4584387',
 '4520291',
 '4301084',
 '4173008',
 '4155247',
 '3879085',
 '3661355',
 '3531324',
 '3461403',
 '3394275',
 '3394243',
 '3312550',
 '3253748',
 '3161047',
 '3144279',
 '3122320',
 '3102222',
 '3096039',
 '3057020',
 '3036045',
 '2944279',
 '2902450',
 '2744707',
 '2705363',
 '2682512',
 '2483496',
 '2447749',
 '2098836',
 '2072961',
 '1933154',
 '1848001',
 '1192790',
 '1190160']

Great - eleven articles. But why hasn’t the Biopython application note been found (PubMed ID 19304878)? Well, as you might have guessed from the variable names, there are not actually PubMed IDs, but PubMed Central IDs. Our application note is the third citing paper in that list, PMCID 2682512.

So, what if (like me) you’d rather get back a list of PubMed IDs? Well we can call ELink again to translate them. This becomes a two step process, so by now you should expect to use the history feature to accomplish it (Section History and WebEnv).

But first, taking the more straightforward approach of making a second (separate) call to ELink:

In [89]:
results2 = Entrez.read(Entrez.elink(dbfrom="pmc", db="pubmed", LinkName="pmc_pubmed",
from_uid=",".join(pmc_ids)))
pubmed_ids = [link["Id"] for link in results2[0]["LinkSetDb"][0]["Link"]]
pubmed_ids

Out[89]:
['26439842',
 '26306092',
 '26288158',
 '25420233',
 '24930144',
 '24849577',
 '24267035',
 '23717802',
 '23300419',
 '22784991',
 '22564897',
 '22553365',
 '22479120',
 '22361291',
 '21801404',
 '21637529',
 '21521828',
 '21500218',
 '21471012',
 '21467571',
 '20813068',
 '20607693',
 '20525384',
 '19698094',
 '19450287',
 '19304878',
 '18645234',
 '18502776',
 '18052533',
 '17888163',
 '17567620',
 '17397254',
 '16095538',
 '15985178']